From 1bf6644ddb16c4a9002212465dd811ca9bd8d609 Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Fri, 15 Sep 2023 03:44:04 +0200 Subject: [PATCH 01/32] setup laterals from points --- hydromt_delft3dfm/dflowfm.py | 135 ++++++++++- hydromt_delft3dfm/utils.py | 210 +++++++++++++++++- hydromt_delft3dfm/workflows/boundaries.py | 118 ++++++++++ tests/data/local_data/laterals_points.geojson | 8 + tests/data/local_data/laterals_series.csv | 26 +++ tests/data/test_data.yaml | 14 ++ 6 files changed, 504 insertions(+), 7 deletions(-) create mode 100644 tests/data/local_data/laterals_points.geojson create mode 100644 tests/data/local_data/laterals_series.csv diff --git a/hydromt_delft3dfm/dflowfm.py b/hydromt_delft3dfm/dflowfm.py index b5b9a252..f5217e96 100644 --- a/hydromt_delft3dfm/dflowfm.py +++ b/hydromt_delft3dfm/dflowfm.py @@ -191,9 +191,7 @@ def __init__( self._crs = CRS.from_user_input(crs) if crs else None self._check_crs() - def setup_region( - self, - ): + def setup_region(self, region): """HYDROMT CORE METHOD NOT USED FOR DFlowFMModel.""" raise ValueError( "setup_region() method not implemented for DFlowFMModel." @@ -1633,6 +1631,112 @@ def setup_1dboundary( da_out, name=f"boundary1d_{da_out.name}_{branch_type}" ) # FIXME: this format cannot be read back due to lack of branch type info from model files + def setup_1dlateral_from_points( + self, + laterals_geodataset_fn: str = None, + lateral_value: float = -2.5, + branch_type: str = "river", + snap_offset: float = 1.0, + ): + """ + Prepares the 1D lateral discharge for a certain `branch_type`. + E.g. '1' m3/s for all lateral locations on the 'river' branches. + + Use ``lateral_fn`` to set the lateral values from a geodataframe of point locations. + Only locations that are snapped to the network of `branch_type` + within a max distance defined in ``snap_offset`` are used. + + The discharge can either be a constant using ``lateral_value`` (default) or + a timeseries read from ``laterals_timeseries_fn``. + If ``laterals_timeseries_fn`` has missing values, the constant ``lateral_value`` will be used. + + The timeseries are clipped to the model time based on the model config + tstart and tstop entries. + + Adds/Updates model layers: + * ** lateral_discharge_{branch_type}** forcing: 1D laterals DataArray + + Parameters + ---------- + laterals_geodataset_fn : str, Path + Path or data source name for geospatial point location file. + * Required variables if a combined point location file: ['index'] with type int + * Required variables ['laterals_discharge'] + laterals_timeseries_fn: str, Path + Path to tabulated timeseries csv file with time index in first column + and location IDs in the first row, + see :py:meth:`hydromt.open_timeseries_from_table`, for details. + NOTE: tabulated timeseries files can only in combination with point location + coordinates be set as a geodataset in the data_catalog yml file. + NOTE: Require equidistant time series + lateral_value : float, optional + Constant value to use for all laterals if ``laterals_timeseries_fn`` is None and to + fill in missing data. By default 0 [m3/s]. + branch_type: str + Type of branch to apply boundaries on. One of ["river", "pipe"]. + snap_offset : float, optional + Snapping tolerance to automatically applying boundaries at the correct network nodes. + By default 0.1, a small snapping is applied to avoid precision errors. + """ + self.logger.info(f"Preparing 1D laterals for {branch_type}.") + network_by_branchtype = self.staticgeoms[f"{branch_type}s"] + refdate, tstart, tstop = self.get_model_time() # time slice + + # 1. read lateral geodataset + # FIXME what if I only have geodataframe? + if laterals_geodataset_fn is not None: + da_bnd = self.data_catalog.get_geodataset( + laterals_geodataset_fn, + geom=self.region.buffer( + self._network_snap_offset + ), # only select data within region of interest + variables=["lateral_discharge"], + time_tuple=(tstart, tstop), + crs=self.crs.to_epsg(), # assume model crs if none defined + ).rename("lateral_discharge") + # error if time mismatch + if np.logical_and( + pd.to_datetime(da_bnd.time.values[0]) == pd.to_datetime(tstart), + pd.to_datetime(da_bnd.time.values[-1]) == pd.to_datetime(tstop), + ): + pass + else: + self.logger.error( + "forcing has different start and end time. Please check the forcing file. support yyyy-mm-dd HH:MM:SS. " + ) + # reproject if needed and convert to location + if da_bnd.vector.crs != self.crs: + da_bnd.vector.to_crs(self.crs) + # get geom + gdf_laterals = da_bnd.vector.to_gdf(reducer=np.mean) + else: + da_bnd = None # FIXME + gdf_laterals = None + + # snap laterlas to selected branches + workflows.find_nearest_branch( + branches=network_by_branchtype.set_index("branchid"), + geometries=gdf_laterals, + maxdist=snap_offset, + ) + gdf_laterals = gdf_laterals.rename( + columns={"branch_id": "branchid", "branch_offset": "chainage"} + ) + + # 3. Derive lateral dataarray + da_out = workflows.compute_forcing_values( # points + gdf=gdf_laterals, + da=da_bnd, + forcing_value=lateral_value, + forcing_type="lateral_discharge", + forcing_unit="m3/s", + logger=self.logger, + ) + # TODO: the polygon is supported by delft3dfm lateral, no convertion to points needed + + # 4. set boundaries + self.set_forcing(da_out, name=f"lateral1d_{branch_type}") + def _setup_1dstructures( self, st_type: str, @@ -1649,7 +1753,6 @@ def _setup_1dstructures( They are then snapped to the existing network within a max distance defined in ``snap_offset`` and will be dropped if not snapped. Finally, crossections are read and set up for the remaining structures. - Parameters ---------- st_type: str, required @@ -3126,6 +3229,26 @@ def read_forcing( ) # Add to forcing self.set_forcing(da_out) + # lateral + if len(ext_model.lateral) > 0: + df_ext = pd.DataFrame([f.__dict__ for f in ext_model.lateral]) + # Forcing dataarrays to prepare for each quantity + name = "lateral_discharge" + # Get the dataframe corresponding to the current variable + df = df_ext + # get network + network1d_nodes = mesh_utils.network1d_nodes_geodataframe( + self.mesh_datasets["network1d"] + ) + node_geoms = network1d_nodes[ + np.isin(network1d_nodes["nodeid"], df.nodeid.values) + ] + branches = self.branches + da_out = utils.read_1dlateral( + df, quantity=name, branches=branches + ) # FIXME check if I need node_geoms or branches + # Add to forcing + self.set_forcing(da_out) # meteo if len(ext_model.meteo) > 0: df_ext = pd.DataFrame([f.__dict__ for f in ext_model.meteo]) @@ -3154,6 +3277,7 @@ def write_forcing(self) -> None: # populate external forcing file utils.write_1dboundary(self.forcing, savedir, ext_fn=ext_fn) utils.write_2dboundary(self.forcing, savedir, ext_fn=ext_fn) + utils.write_1dlateral(self.forcing, savedir, ext_fn=ext_fn) utils.write_meteo(self.forcing, savedir, ext_fn=ext_fn) self.set_config("external_forcing.extforcefilenew", ext_fn) @@ -3197,8 +3321,7 @@ def read_mesh(self): branches = utils.read_branches_gui(branches, self.dfmmodel) # Set branches - self._branches = branches - self.set_geoms(branches, "branches") + self.set_branches(branches) def write_mesh(self, write_gui=True): """Write 1D branches and 2D mesh at in model ready format.""" diff --git a/hydromt_delft3dfm/utils.py b/hydromt_delft3dfm/utils.py index e4f92dcc..654d910f 100644 --- a/hydromt_delft3dfm/utils.py +++ b/hydromt_delft3dfm/utils.py @@ -17,6 +17,7 @@ ForcingModel, FrictionModel, Meteo, + Lateral, PolyFile, StorageNodeModel, StructureModel, @@ -731,6 +732,213 @@ def write_1dboundary(forcing: Dict, savedir: str = None, ext_fn: str = None) -> return forcing_fn, ext_fn +def read_1dlateral( + df: pd.DataFrame, + quantity: str, + nodes: gpd.GeoDataFrame = None, + branches: gpd.GeoDataFrame = None, +) -> xr.DataArray: + """ + Read for a specific quantity the corresponding external and forcing files and parse to xarray + # TODO: support external forcing for 2D. + + Parameters + ---------- + df: pd.DataFrame + External Model DataFrame filtered for quantity. + quantity: str + Name of quantity (eg 'waterlevel'). + nodes: gpd.GeoDataFrame + Nodes locations of the boundary in df. + + Returns + ------- + da_out: xr.DataArray + External and focing values combined into a DataArray for variable quantity. + """ + # Initialise dataarray attributes + # TODO change to read using branchid and chainage + # TODO add read using polygons + bc = {"quantity": quantity} + + # Assume one discharge (lateral specific) file (hydromt writer) and read + forcing = df.discharge.iloc[0] + df_forcing = pd.DataFrame([f.__dict__ for f in forcing.forcing]) + + # Get data + # Check if all constant + if np.all(df_forcing.function == "constant"): + # Prepare data + data = np.array([v[0][0] for v in df_forcing.datablock]) + data = data + df_forcing.offset.values * df_forcing.factor.values + # Prepare dataarray properties + dims = ["index"] + coords = dict(index=df_forcing.name) + bc["function"] = "constant" + bc["units"] = df_forcing.quantityunitpair.iloc[0][0].unit + bc["factor"] = 1 + bc["offset"] = 0 + # Check if all timeseries + elif np.all(df_forcing.function == "timeseries"): + # Prepare data + data = list() + for i in np.arange(len(df_forcing.datablock)): + v = df_forcing.datablock.iloc[i] + offset = df_forcing.offset.iloc[i] + factor = df_forcing.factor.iloc[i] + databl = [n[1] * factor + offset for n in v] + data.append(databl) + data = np.array(data) + # Assume unique times + times = np.array([n[0] for n in df_forcing.datablock.iloc[0]]) + # Prepare dataarray properties + dims = ["index", "time"] + coords = dict(index=df_forcing.name, time=times) + bc["function"] = "timeseries" + bc["units"] = df_forcing.quantityunitpair.iloc[0][1].unit + bc["time_unit"] = df_forcing.quantityunitpair.iloc[0][0].unit + bc["factor"] = 1 + bc["offset"] = 0 + # Else not implemented yet + else: + raise NotImplementedError( + f"ForcingFile with several function for a single variable not implemented yet. Skipping reading forcing for variable {quantity}." + ) + + # Get lateral locations + if any(df.nodeid.values): + # TODO test when implementing laterals on nodes + nodeids = df.nodeid.values + nodeids = nodeids[nodeids != "nan"] + node_geoms = nodes.set_index("name").reindex(nodeids) + elif any(df.branchid.values): + branchids = df.branchid.values + branchids = branchids[branchids != "nan"] + df["geometry"] = [ + branches.set_index("branchid") + .loc[i.branchid, "geometry"] + .interpolate(i.chainage) + for i in df.itertuples() + ] + node_geoms = df + else: # TODO polygon + pass + + # branches + # get crsloc geometry + + # # get rid of missing geometries + # index_name = node_geoms.index.name + # node_geoms = pd.DataFrame([row for n, row in node_geoms.iterrows() if row["geometry"] is not None]) + # node_geoms.index.name = index_name + # FIXME polygon geometry? + xs, ys = np.vectorize( + lambda p: (np.nan, np.nan) if p is None else (p.xy[0][0], p.xy[1][0]) + )(node_geoms["geometry"]) + coords["x"] = ("index", xs) + coords["y"] = ("index", ys) + + # Prep DataArray and add to forcing + da_out = xr.DataArray( + data=data, + dims=dims, + coords=coords, + attrs=bc, + ) + da_out.name = f"lateral1d_{quantity}" + + return da_out + + +def write_1dlateral(forcing: Dict, savedir: str = None, ext_fn: str = None) -> Tuple: + """ " + write 1dlateral ext and bc files from forcing dict. + + Parameters + ---------- + forcing: dict of xarray DataArray + Dict of lateral DataArray for each variable + Only forcing that starts with "lateral1d" is recognised. + savedir: str, optional + path to the directory where to save the file. + ext_fn: str or Path, optional + Path of the external forcing file (.ext) in which this function will append to. + """ + # filter for 1d lateral + forcing = { + key: forcing[key] for key in forcing.keys() if key.startswith("lateral1d") + } + if len(forcing) == 0: + return + + extdict = list() + bcdict = list() + # Loop over forcing dict + for name, da in forcing.items(): + for i in da.index.values: + if da.name == "lateral_discharge": + bc = da.attrs.copy() + # Lateral + ext = dict() + ext["id"] = str(i) + ext["name"] = str(i) + ext["quantity"] = "discharge" + ext["locationType"] = "1d" + if "nodeid" in da.coords: # not used + ext["nodeid"] = da.coords["nodeid"].values[0] + elif "branchid" in da.coords: # for point laterals + ext["branchid"] = da.coords["branchid"].values[0] + ext["chainage"] = da.coords["chainage"].values[0] + elif "xcoordinates" in da.coords: # for polygon laterals + ext["numcoordinates"] = da.coords["numcoordinates"].values[0] + # ext["xcoordinates"] = da["xcoordinates"] # TODO convert to something like list? + # ext["ycoordinates"] = da["ycoordinates"] + else: + raise ValueError("Not supported.") + extdict.append(ext) + # Forcing + bc["name"] = str(i) + if bc["function"] == "constant": + # one quantityunitpair + bc["quantityunitpair"] = [ + {"quantity": da.name, "unit": bc["units"]} + ] + # only one value column (no times) + bc["datablock"] = [[da.sel(index=i).values.item()]] + else: + # two quantityunitpair + bc["quantityunitpair"] = [ + {"quantity": "time", "unit": bc["time_unit"]}, + {"quantity": da.name, "unit": bc["units"]}, + ] + bc.pop("time_unit") + # time/value datablock + bc["datablock"] = [ + [t, x] for t, x in zip(da.time.values, da.sel(index=i).values) + ] + bc.pop("quantity") + bc.pop("units") + bcdict.append(bc) + + # write forcing file + forcing_model = ForcingModel(forcing=bcdict) + forcing_fn = f'lateral1d_{ext["quantity"]}.bc' + forcing_model.save(join(savedir, forcing_fn), recurse=True) + + # add forcingfile to ext, note forcing file is called discharge for lateral + extdicts = [] + for ext in extdict: + ext["discharge"] = forcing_fn + extdicts.append(ext) + + # write external forcing file + if ext_fn is not None: + # write to external forcing file + write_ext(extdicts, savedir, ext_fn=ext_fn, block_name="lateral", mode="append") + + return forcing_fn, ext_fn + + def read_2dboundary(df: pd.DataFrame, workdir: Path = Path.cwd()) -> xr.DataArray: """ Read a 2d boundary forcing location and values, and parse to xarray. @@ -1091,7 +1299,7 @@ def write_ext( if block_name == "boundary": ext_model.boundary.append(Boundary(**{**extdicts[i]})) elif block_name == "lateral": - raise NotImplementedError("laterals are not yet supported.") + ext_model.lateral.append(Lateral(**{**extdicts[i]})) elif block_name == "meteo": ext_model.meteo.append(Meteo(**{**extdicts[i]})) else: diff --git a/hydromt_delft3dfm/workflows/boundaries.py b/hydromt_delft3dfm/workflows/boundaries.py index 223d7bd6..105c465d 100644 --- a/hydromt_delft3dfm/workflows/boundaries.py +++ b/hydromt_delft3dfm/workflows/boundaries.py @@ -23,6 +23,7 @@ "compute_boundary_values", "compute_2dboundary_values", "compute_meteo_forcings", + "compute_forcing_values", ] @@ -605,3 +606,120 @@ def compute_meteo_forcings( da_out.dropna(dim="time") return da_out + + +def compute_forcing_values( + gdf: gpd.GeoDataFrame, + da: xr.DataArray = None, + forcing_value: float = -2.5, + forcing_type: str = "waterlevelbnd", + forcing_unit: str = "m", + logger=logger, +): + """ + Compute 1d forcing values. Used for 1D lateral point locations. + # TODO harmonize for all 1D forcings (boundary + laterals) + + Parameters + ---------- + gdf : gpd.GeoDataFrame + Point locations of the 1D forcings to which to add data. + + * Required variables: ['branchid', 'chainage'] + da : xr.DataArray, optional + xr.DataArray containing the forcing timeseries values. If None, uses a constant values for all forcings. + + * Required variables: [``forcing_type``] + + forcing_value : float, optional + Constant value to use for all forcings if ``da`` is None and to + fill in missing data. + forcing_type : {'lateral_discharge'} + Type of forcing to use. + forcing_unit : {'m3/s'} + Unit corresponding to [forcing_type]. + logger + Logger to log messages. + """ + # Timeseries boundary values + if da is not None: + logger.info(f"Preparing 1D forcing type {forcing_type} from timeseries.") + + # get boundary data freq in seconds + _TIMESTR = {"D": "days", "H": "hours", "T": "minutes", "S": "seconds"} + dt = pd.to_timedelta((da.time[1].values - da.time[0].values)) + freq = dt.resolution_string + multiplier = 1 + if freq == "D": + logger.warning( + "time unit days is not supported by the current GUI version: 2022.04" + ) # converting to hours as temporary solution # FIXME: day is converted to hours temporarily + multiplier = 24 + if len(pd.date_range(da.time[0].values, da.time[-1].values, freq=dt)) != len( + da.time + ): + logger.error("does not support non-equidistant time-series.") + freq_name = _TIMESTR[freq] + freq_step = getattr(dt.components, freq_name) + bd_times = np.array([(i * freq_step) for i in range(len(da.time))]) + if multiplier == 24: + bd_times = np.array( + [(i * freq_step * multiplier) for i in range(len(da.time))] + ) + freq_name = "hours" + + # instantiate xr.DataArray for bnd data + da_out = xr.DataArray( + data=da.data, + dims=["index", "time"], + coords=dict( + index=gdf.index, + time=bd_times, + x=("index", gdf.geometry.x.values), + y=("index", gdf.geometry.y.values), + branchid=("index", gdf.branchid.values), + chainage=("index", gdf.chainage.values), + ), + attrs=dict( + function="TimeSeries", + timeInterpolation="Linear", + quantity=f"{forcing_type}", + units=f"{forcing_unit}", + time_unit=f"{freq_name} since {pd.to_datetime(da.time[0].values)}", # support only yyyy-mm-dd HH:MM:SS + ), + ) + + # fill in na using default + da_out = da_out.fillna(forcing_value) + + # drop na in time + da_out.dropna(dim="time") + + # add name + da_out.name = f"{forcing_type}" + else: + logger.info( + f"Using constant value {forcing_value} {forcing_unit} for all {forcing_type} forcings." + ) + # instantiate xr.DataArray for bnd data with forcing_type directly + da_out = xr.DataArray( + data=np.full((len(gdf.index)), forcing_value, dtype=np.float32), + dims=["index"], + coords=dict( + index=gdf.index, + x=("index", gdf.geometry.x.values), + y=("index", gdf.geometry.y.values), + branchid=("index", gdf.branchid.values), + chainage=("index", gdf.chainage.values), + ), + attrs=dict( + function="constant", + offset=0.0, + factor=1.0, + quantity=f"{forcing_type}", + units=f"{forcing_unit}", + ), + ) + da_out.name = f"{forcing_type}" + + return da_out.drop_duplicates(dim=...) diff --git a/tests/data/local_data/laterals_points.geojson b/tests/data/local_data/laterals_points.geojson new file mode 100644 index 00000000..5c41b0cb --- /dev/null +++ b/tests/data/local_data/laterals_points.geojson @@ -0,0 +1,8 @@ +{ +"type": "FeatureCollection", +"name": "laterals_points", +"crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, +"features": [ +{ "type": "Feature", "properties": { "id": 1 }, "geometry": { "type": "Point", "coordinates": [ 664060.642805648967624, 1526146.820236828410998 ] } } +] +} diff --git a/tests/data/local_data/laterals_series.csv b/tests/data/local_data/laterals_series.csv new file mode 100644 index 00000000..45d45272 --- /dev/null +++ b/tests/data/local_data/laterals_series.csv @@ -0,0 +1,26 @@ +datetime,0,1 +2020-1-1 00:00,-1,0 +2020-1-1 01:00,-1,0 +2020-1-1 02:00,-1,0 +2020-1-1 03:00,-1,0 +2020-1-1 04:00,-1,0 +2020-1-1 05:00,-1,0 +2020-1-1 06:00,-1,0 +2020-1-1 07:00,-1,0 +2020-1-1 08:00,-1,0 +2020-1-1 09:00,-1,0 +2020-1-1 10:00,-1,0 +2020-1-1 11:00,-1,0 +2020-1-1 12:00,-1,0 +2020-1-1 13:00,-1,0 +2020-1-1 14:00,-1,0 +2020-1-1 15:00,-1,0 +2020-1-1 16:00,-1,0 +2020-1-1 17:00,-1,0 +2020-1-1 18:00,-1,0 +2020-1-1 19:00,-1,0 +2020-1-1 20:00,-1,0 +2020-1-1 21:00,-1,0 +2020-1-1 22:00,-1,0 +2020-1-1 23:00,-1,0 +2020-1-2 00:00,-1,0 diff --git a/tests/data/test_data.yaml b/tests/data/test_data.yaml index 070814fc..9a47da00 100644 --- a/tests/data/test_data.yaml +++ b/tests/data/test_data.yaml @@ -79,6 +79,20 @@ crs: 32647 kwargs: fn_data: local_data/boundaries_series.csv +1D_laterals_points: + data_type: GeoDataFrame + driver: vector + path: local_data/laterals_points.geojson + crs: 32647 +1D_laterals_timeseries: + path: local_data/laterals_points.geojson + data_type: GeoDataset + driver: vector + crs: 32647 + rename: + 1D_laterals_timeseries: lateral_discharge + kwargs: + fn_data: local_data/laterals_series.csv roads: path: local_data/roads.tiff data_type: RasterDataset From 56cb186bf3c2a00453695a4fb07612e1c968e351 Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Fri, 15 Sep 2023 10:59:32 +0200 Subject: [PATCH 02/32] setup laterals using polygons --- hydromt_delft3dfm/dflowfm.py | 115 ++++++++++-- hydromt_delft3dfm/utils.py | 140 ++++++++------- hydromt_delft3dfm/workflows/boundaries.py | 164 +++++++++++++++++- .../data/local_data/laterals_polygons.geojson | 8 + 4 files changed, 349 insertions(+), 78 deletions(-) create mode 100644 tests/data/local_data/laterals_polygons.geojson diff --git a/hydromt_delft3dfm/dflowfm.py b/hydromt_delft3dfm/dflowfm.py index f5217e96..33c482ed 100644 --- a/hydromt_delft3dfm/dflowfm.py +++ b/hydromt_delft3dfm/dflowfm.py @@ -1631,6 +1631,53 @@ def setup_1dboundary( da_out, name=f"boundary1d_{da_out.name}_{branch_type}" ) # FIXME: this format cannot be read back due to lack of branch type info from model files + def _read_laterals(self, laterals_geodataset_fn): + """Reads laterals""" + + refdate, tstart, tstop = self.get_model_time() # time slice + + if ( + laterals_geodataset_fn is not None + and self.data_catalog[laterals_geodataset_fn].data_type == "GeoDataset" + ): + da_lat = self.data_catalog.get_geodataset( + laterals_geodataset_fn, + geom=self.region.buffer( + self._network_snap_offset + ), # only select data within region of interest + variables=["lateral_discharge"], + time_tuple=(tstart, tstop), + crs=self.crs.to_epsg(), # assume model crs if none defined + ).rename("lateral_discharge") + # error if time mismatch + if np.logical_and( + pd.to_datetime(da_lat.time.values[0]) == pd.to_datetime(tstart), + pd.to_datetime(da_lat.time.values[-1]) == pd.to_datetime(tstop), + ): + pass + else: + self.logger.error( + "forcing has different start and end time. Please check the forcing file. support yyyy-mm-dd HH:MM:SS. " + ) + # reproject if needed and convert to location + if da_lat.vector.crs != self.crs: + da_lat.vector.to_crs(self.crs) + # get geom + gdf_laterals = da_lat.vector.to_gdf(reducer=np.mean) + elif ( + laterals_geodataset_fn is not None + and self.data_catalog[laterals_geodataset_fn].data_type == "GeoDataFrame" + ): + gdf_laterals = self.data_catalog.get_geodataframe( + laterals_geodataset_fn, + geom=self.region.buffer(self._network_snap_offset), + ) + da_lat = None + else: + gdf_laterals = None + da_lat = None + return gdf_laterals, da_lat + def setup_1dlateral_from_points( self, laterals_geodataset_fn: str = None, @@ -1735,7 +1782,57 @@ def setup_1dlateral_from_points( # TODO: the polygon is supported by delft3dfm lateral, no convertion to points needed # 4. set boundaries - self.set_forcing(da_out, name=f"lateral1d_{branch_type}") + self.set_forcing(da_out, name=f"lateral1d_points") + + def setup_1dlateral_from_polygons( + self, + laterals_geodataset_fn: str = None, + lateral_value: float = -2.5, + ): + """ + Prepares the 1D lateral discharge within a polygon. + E.g. '1' m3/s for all lateral polygons. + + Use ``laterals_geodataset_fn`` to set the lateral values from a geodatasets containing of polygons and (optionaly) timeseries. + + The discharge can either be a constant using ``lateral_value`` (default) or + a timeseries read from ``laterals_geodataset_fn``. + If ``laterals_geodataset_fn`` has missing values, the constant ``lateral_value`` will be used. + + The timeseries are clipped to the model time based on the model config + tstart and tstop entries. + + Adds/Updates model layers: + * ** lateral1d_polygon** forcing: 1D laterals DataArray + + Parameters + ---------- + laterals_geodataset_fn : str, Path + Path or data source name for geospatial point location file. + * Required variables if a combined point location file: ['index'] with type int + * Required variables ['laterals_discharge'] + lateral_value : float, optional + Constant value to use for all laterals if ``laterals_timeseries_fn`` is None and to + fill in missing data. By default 0 [m3/s]. + """ + self.logger.info(f"Preparing 1D laterals for polygons.") + + # 1. read lateral geodataset + # FIXME what if I only have geodataframe? + gdf_laterals, da_lat = self._read_laterals(laterals_geodataset_fn) + + # 2. Derive lateral dataarray + da_out = workflows.compute_forcing_values_polygon( + gdf=gdf_laterals, + da=da_lat, + forcing_value=lateral_value, + forcing_type="lateral_discharge", + forcing_unit="m3/s", + logger=self.logger, + ) + + # 3. set boundaries + self.set_forcing(da_out, name=f"lateral1d_polygons") def _setup_1dstructures( self, @@ -3232,21 +3329,9 @@ def read_forcing( # lateral if len(ext_model.lateral) > 0: df_ext = pd.DataFrame([f.__dict__ for f in ext_model.lateral]) - # Forcing dataarrays to prepare for each quantity - name = "lateral_discharge" - # Get the dataframe corresponding to the current variable - df = df_ext - # get network - network1d_nodes = mesh_utils.network1d_nodes_geodataframe( - self.mesh_datasets["network1d"] - ) - node_geoms = network1d_nodes[ - np.isin(network1d_nodes["nodeid"], df.nodeid.values) - ] - branches = self.branches da_out = utils.read_1dlateral( - df, quantity=name, branches=branches - ) # FIXME check if I need node_geoms or branches + df_ext, branches=self.branches + ) # TODO extend support to get laterals on nodes #78 # Add to forcing self.set_forcing(da_out) # meteo diff --git a/hydromt_delft3dfm/utils.py b/hydromt_delft3dfm/utils.py index 654d910f..a86ec34f 100644 --- a/hydromt_delft3dfm/utils.py +++ b/hydromt_delft3dfm/utils.py @@ -22,9 +22,10 @@ StorageNodeModel, StructureModel, ) -from shapely.geometry import Point +from shapely.geometry import Point, Polygon from .workflows import helper +from .workflows import boundaries __all__ = [ "read_branches_gui", @@ -734,22 +735,23 @@ def write_1dboundary(forcing: Dict, savedir: str = None, ext_fn: str = None) -> def read_1dlateral( df: pd.DataFrame, - quantity: str, + quantity: str = "lateral_discharge", nodes: gpd.GeoDataFrame = None, branches: gpd.GeoDataFrame = None, ) -> xr.DataArray: """ Read for a specific quantity the corresponding external and forcing files and parse to xarray - # TODO: support external forcing for 2D. Parameters ---------- df: pd.DataFrame External Model DataFrame filtered for quantity. quantity: str - Name of quantity (eg 'waterlevel'). + Name of quantity. Supports only "lateral_discharge". nodes: gpd.GeoDataFrame - Nodes locations of the boundary in df. + Nodes locations of the laterals in df. + branches: gpd.GeoDataFrame + Branches on which the laterals in df are located. Returns ------- @@ -757,8 +759,6 @@ def read_1dlateral( External and focing values combined into a DataArray for variable quantity. """ # Initialise dataarray attributes - # TODO change to read using branchid and chainage - # TODO add read using polygons bc = {"quantity": quantity} # Assume one discharge (lateral specific) file (hydromt writer) and read @@ -795,6 +795,7 @@ def read_1dlateral( dims = ["index", "time"] coords = dict(index=df_forcing.name, time=times) bc["function"] = "timeseries" + bc["timeinterpolation"] = df_forcing.timeinterpolation.iloc[0] bc["units"] = df_forcing.quantityunitpair.iloc[0][1].unit bc["time_unit"] = df_forcing.quantityunitpair.iloc[0][0].unit bc["factor"] = 1 @@ -805,47 +806,53 @@ def read_1dlateral( f"ForcingFile with several function for a single variable not implemented yet. Skipping reading forcing for variable {quantity}." ) - # Get lateral locations - if any(df.nodeid.values): - # TODO test when implementing laterals on nodes - nodeids = df.nodeid.values - nodeids = nodeids[nodeids != "nan"] - node_geoms = nodes.set_index("name").reindex(nodeids) - elif any(df.branchid.values): - branchids = df.branchid.values - branchids = branchids[branchids != "nan"] - df["geometry"] = [ - branches.set_index("branchid") - .loc[i.branchid, "geometry"] - .interpolate(i.chainage) - for i in df.itertuples() - ] - node_geoms = df - else: # TODO polygon - pass - - # branches - # get crsloc geometry - - # # get rid of missing geometries - # index_name = node_geoms.index.name - # node_geoms = pd.DataFrame([row for n, row in node_geoms.iterrows() if row["geometry"] is not None]) - # node_geoms.index.name = index_name - # FIXME polygon geometry? - xs, ys = np.vectorize( - lambda p: (np.nan, np.nan) if p is None else (p.xy[0][0], p.xy[1][0]) - )(node_geoms["geometry"]) - coords["x"] = ("index", xs) - coords["y"] = ("index", ys) - - # Prep DataArray and add to forcing - da_out = xr.DataArray( - data=data, - dims=dims, - coords=coords, - attrs=bc, - ) - da_out.name = f"lateral1d_{quantity}" + # Get lateral locations and update dimentions and coordinates + if any(df.numcoordinates.values): + # polygons + df["geometry"] = df.apply( + lambda row: Polygon(zip(row["xcoordinates"], row["ycoordinates"])), axis=1 + ) + coords_dict = boundaries.get_geometry_coords_for_polygons(gpd.GeoDataFrame(df)) + # Updates the data + data = np.tile( + np.expand_dims(data, axis=-1), + (1, 1, len(coords_dict["numcoordinates"])), + ) + dims.append("numcoordinates") + coords.update(coords_dict) + # Prep DataArray and add to forcing + da_out = xr.DataArray( + data=data, + dims=dims, + coords=coords, + attrs=bc, + ) + da_out.name = f"lateral1d_polygons" + else: + # points + if any(df.nodeid.values): + # TODO laterals on nodes #78 + pass + elif any(df.branchid.values): + branchids = df.branchid.values + branchids = branchids[branchids != "nan"] + df["geometry"] = [ + branches.set_index("branchid") + .loc[i.branchid, "geometry"] + .interpolate(i.chainage) + for i in df.itertuples() + ] + # Updates the data + coords["x"] = ("index", np.array(df.geometry.x)) + coords["y"] = ("index", np.array(df.geometry.y)) + # Prep DataArray and add to forcing + da_out = xr.DataArray( + data=data, + dims=dims, + coords=coords, + attrs=bc, + ) + da_out.name = f"lateral1d_points" return da_out @@ -876,28 +883,37 @@ def write_1dlateral(forcing: Dict, savedir: str = None, ext_fn: str = None) -> T # Loop over forcing dict for name, da in forcing.items(): for i in da.index.values: - if da.name == "lateral_discharge": - bc = da.attrs.copy() + if da.attrs["quantity"] == "lateral_discharge": # Lateral + latid = f"{name}_{i}" + # Ext ext = dict() - ext["id"] = str(i) - ext["name"] = str(i) + ext["id"] = latid + ext["name"] = latid ext["quantity"] = "discharge" ext["locationType"] = "1d" - if "nodeid" in da.coords: # not used - ext["nodeid"] = da.coords["nodeid"].values[0] + if "nodeid" in da.coords: + # TODO laterals on nodes #78 + # ext["nodeid"] = da.sel(index=i).coords["nodeid"].item() + pass elif "branchid" in da.coords: # for point laterals - ext["branchid"] = da.coords["branchid"].values[0] - ext["chainage"] = da.coords["chainage"].values[0] - elif "xcoordinates" in da.coords: # for polygon laterals - ext["numcoordinates"] = da.coords["numcoordinates"].values[0] - # ext["xcoordinates"] = da["xcoordinates"] # TODO convert to something like list? - # ext["ycoordinates"] = da["ycoordinates"] + ext["branchid"] = da.sel(index=i).coords["branchid"].item() + ext["chainage"] = da.sel(index=i).coords["chainage"].item() + elif "numcoordinates" in da.coords: # for polygon laterals + ext["xcoordinates"] = da.sel(index=i)[ + "xcoordinates" + ].values.tolist() + ext["ycoordinates"] = da.sel(index=i)[ + "ycoordinates" + ].values.tolist() + ext["numcoordinates"] = len(ext["ycoordinates"]) + da = da.isel(numcoordinates=0) # drop coordinates else: raise ValueError("Not supported.") extdict.append(ext) # Forcing - bc["name"] = str(i) + bc = da.attrs.copy() + bc["name"] = latid if bc["function"] == "constant": # one quantityunitpair bc["quantityunitpair"] = [ @@ -1299,7 +1315,7 @@ def write_ext( if block_name == "boundary": ext_model.boundary.append(Boundary(**{**extdicts[i]})) elif block_name == "lateral": - ext_model.lateral.append(Lateral(**{**extdicts[i]})) + ext_model.lateral.append(Lateral(**extdicts[i])) elif block_name == "meteo": ext_model.meteo.append(Meteo(**{**extdicts[i]})) else: diff --git a/hydromt_delft3dfm/workflows/boundaries.py b/hydromt_delft3dfm/workflows/boundaries.py index 105c465d..714f14d7 100644 --- a/hydromt_delft3dfm/workflows/boundaries.py +++ b/hydromt_delft3dfm/workflows/boundaries.py @@ -8,7 +8,7 @@ import numpy as np import pandas as pd import xarray as xr -from shapely.geometry import Point +from shapely.geometry import Point, Polygon from hydromt_delft3dfm import graph_utils @@ -24,6 +24,8 @@ "compute_2dboundary_values", "compute_meteo_forcings", "compute_forcing_values", + "compute_forcing_values_polygon", + "get_geometry_coords_for_polygons", ] @@ -721,5 +723,165 @@ def compute_forcing_values( ), ) da_out.name = f"{forcing_type}" + return da_out + + +def get_geometry_coords_for_polygons(gdf): + """Gets static coordinates from polygon inputs. + Inlcudes numcoordinates, xcoordinates and ycoordinates""" + if gdf.geometry.type.iloc[0] == "Polygon": + # Get the maximum number of coordinates for any polygon + max_coords = gdf["geometry"].apply(lambda x: len(x.exterior.coords[:])).max() + + def get_xcoords(geom): + coords = [xy[0] for xy in geom.exterior.coords[:]] + return np.pad( + coords, + (0, max_coords - len(coords)), + "constant", + constant_values=np.nan, + ) + + def get_ycoords(geom): + coords = [xy[1] for xy in geom.exterior.coords[:]] + return np.pad( + coords, + (0, max_coords - len(coords)), + "constant", + constant_values=np.nan, + ) + + # Create the 2D arrays + x_2d = np.vstack(gdf["geometry"].apply(get_xcoords)) + y_2d = np.vstack(gdf["geometry"].apply(get_ycoords)) + + return dict( + index=gdf.index, + numcoordinates=np.arange(max_coords), + xcoordinates=(("index", "numcoordinates"), x_2d), + ycoordinates=(("index", "numcoordinates"), y_2d), + ) + + +def compute_forcing_values_polygon( + gdf: gpd.GeoDataFrame, + da: xr.DataArray = None, + forcing_value: float = -2.5, + forcing_type: str = "waterlevelbnd", + forcing_unit: str = "m", + logger=logger, +): + """ + Compute 1d forcing values. Used for 1D lateral polygon locations. + + Parameters + ---------- + gdf : gpd.GeoDataFrame + Point locations of the 1D forcings to which to add data. + + * Required variables: ['geometry'] + da : xr.DataArray, optional + xr.DataArray containing the forcing timeseries values. If None, uses a constant values for all forcings. + + * Required variables: [``forcing_type``] + + forcing_value : float, optional + Constant value to use for all forcings if ``da`` is None and to + fill in missing data. + forcing_type : {'lateral_discharge'} + Type of forcing to use. + forcing_unit : {'m3/s'} + Unit corresponding to [forcing_type]. + logger + Logger to log messages. + """ + # Timeseries boundary values + if da is not None: + logger.info(f"Preparing 1D forcing type {forcing_type} from timeseries.") + + # get boundary data freq in seconds + _TIMESTR = {"D": "days", "H": "hours", "T": "minutes", "S": "seconds"} + dt = pd.to_timedelta((da.time[1].values - da.time[0].values)) + freq = dt.resolution_string + multiplier = 1 + if freq == "D": + logger.warning( + "time unit days is not supported by the current GUI version: 2022.04" + ) # converting to hours as temporary solution # FIXME: day is converted to hours temporarily + multiplier = 24 + if len(pd.date_range(da.time[0].values, da.time[-1].values, freq=dt)) != len( + da.time + ): + logger.error("does not support non-equidistant time-series.") + freq_name = _TIMESTR[freq] + freq_step = getattr(dt.components, freq_name) + bd_times = np.array([(i * freq_step) for i in range(len(da.time))]) + if multiplier == 24: + bd_times = np.array( + [(i * freq_step * multiplier) for i in range(len(da.time))] + ) + freq_name = "hours" + + # instantiate xr.Dataset for bnd data + coords_dict = get_geometry_coords_for_polygons(gdf) + # Prepare the data + data_3d = np.tile( + np.expand_dims(da.data, axis=1), (1, len(coords_dict["numcoordinates"]), 1) + ) + # Create the DataArray + da_out = xr.DataArray( + data=data_3d, + dims=("index", "numcoordinates", "time"), + coords={ + "index": coords_dict["index"], + "numcoordinates": coords_dict["numcoordinates"], + "xcoordinates": coords_dict["xcoordinates"], + "ycoordinates": coords_dict["ycoordinates"], + "time": bd_times, + }, + attrs=dict( + function="TimeSeries", + timeInterpolation="Linear", + quantity=f"{forcing_type}", + units=f"{forcing_unit}", + time_unit=f"{freq_name} since {pd.to_datetime(da.time[0].values)}", # support only yyyy-mm-dd HH:MM:SS + ), + ) + # fill in na using default + da_out = da_out.fillna(forcing_value) + + # drop na in time + da_out.dropna(dim="time") + + # add name + da_out.name = f"{forcing_type}" + else: + logger.info( + f"Using constant value {forcing_value} {forcing_unit} for all {forcing_type} forcings." + ) + # instantiate xr.DataSet for bnd data with forcing_type directly + coords_dict = get_geometry_coords_for_polygons(gdf) + data_3d = np.full( + (len(coords_dict["index"]), len(coords_dict["numcoordinates"])), + forcing_value, + dtype=np.float32, + ) + da_out = xr.DataArray( + data=data_3d, + coords={ + "index": coords_dict["index"], + "numcoordinates": coords_dict["numcoordinates"], + "xcoordinates": coords_dict["xcoordinates"], + "ycoordinates": coords_dict["ycoordinates"], + }, + attrs=dict( + function="constant", + offset=0.0, + factor=1.0, + quantity=f"{forcing_type}", + units=f"{forcing_unit}", + ), + ) + da_out.name = f"{forcing_type}" return da_out.drop_duplicates(dim=...) diff --git a/tests/data/local_data/laterals_polygons.geojson b/tests/data/local_data/laterals_polygons.geojson new file mode 100644 index 00000000..adc3121e --- /dev/null +++ b/tests/data/local_data/laterals_polygons.geojson @@ -0,0 +1,8 @@ +{ +"type": "FeatureCollection", +"name": "laterals_polygons", +"crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, +"features": [ +{ "type": "Feature", "properties": { "ID": 1 }, "geometry": { "type": "Polygon", "coordinates": [ [ [ 663197.491382142878138, 1525273.298445626860484 ], [ 663634.263768262113445, 1524966.791507999645546 ], [ 662898.647117956192233, 1524208.186837371671572 ], [ 662500.188099040649831, 1524867.176753270439804 ], [ 663197.491382142878138, 1525273.298445626860484 ] ] ] } } +] +} From 0b546b1971016301cd952bc6b312b147d73977c6 Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Fri, 15 Sep 2023 11:46:30 +0200 Subject: [PATCH 03/32] Finalise setup 1d laterals --- examples/dflowfm_local/dflowfm/bnd.ext | 25 +++- examples/dflowfm_local/dflowfm/fieldFile.ini | 2 +- examples/dflowfm_local/dflowfm/fm_net.nc | Bin 152476 -> 152476 bytes examples/dflowfm_local/dimr_config.xml | 2 +- examples/dflowfm_local/geoms/bridges.geojson | 4 +- examples/dflowfm_local/geoms/culverts.geojson | 2 +- hydromt_delft3dfm/dflowfm.py | 107 +++++--------- hydromt_delft3dfm/utils.py | 1 + hydromt_delft3dfm/workflows/boundaries.py | 137 +++++++++--------- tests/data/dflowfm_build_local.yml | 10 ++ tests/data/local_data/laterals_series.csv | 52 +++---- tests/data/test_data.yaml | 15 ++ 12 files changed, 186 insertions(+), 171 deletions(-) diff --git a/examples/dflowfm_local/dflowfm/bnd.ext b/examples/dflowfm_local/dflowfm/bnd.ext index 0a0e1c9e..6bcb1413 100644 --- a/examples/dflowfm_local/dflowfm/bnd.ext +++ b/examples/dflowfm_local/dflowfm/bnd.ext @@ -16,13 +16,30 @@ forcingFile = boundaryconditions1d_waterlevelbnd.bc [Boundary] quantity = waterlevelbnd -locationFile = 1.pli -forcingFile = boundaryconditions2d_1.bc +locationFile = 0.pli +forcingFile = boundaryconditions2d_0.bc [Boundary] quantity = waterlevelbnd -locationFile = 0.pli -forcingFile = boundaryconditions2d_0.bc +locationFile = 1.pli +forcingFile = boundaryconditions2d_1.bc + +[Lateral] +id = lateral1d_points_0 +name = lateral1d_points_0 +locationType = 1d +branchId = branch_7 +chainage = 370.839 +discharge = lateral1d_discharge.bc + +[Lateral] +id = lateral1d_polygons_0 +name = lateral1d_polygons_0 +locationType = 1d +numCoordinates = 5 +xCoordinates = 663197.4913821429 663634.2637682621 662898.6471179562 662500.1880990406 663197.4913821429 +yCoordinates = 1525273.2984456269 1524966.7915079996 1524208.1868373717 1524867.1767532704 1525273.2984456269 +discharge = lateral1d_discharge.bc [Meteo] quantity = rainfall_rate # Name of the quantity. See UM Section C.5.3 diff --git a/examples/dflowfm_local/dflowfm/fieldFile.ini b/examples/dflowfm_local/dflowfm/fieldFile.ini index e920f597..feea4905 100644 --- a/examples/dflowfm_local/dflowfm/fieldFile.ini +++ b/examples/dflowfm_local/dflowfm/fieldFile.ini @@ -11,7 +11,7 @@ dataFileType = GeoTIFF # Type of dataFile. interpolationMethod = averaging # Type of (spatial) interpolation. operand = O # How this data is combined with previous data for the same quantity (if any). averagingType = nearestNb # Type of averaging, if interpolationMethod=averaging . -averagingRelSize = 1.34 # Relative search cell size for averaging. +averagingRelSize = 1.01 # Relative search cell size for averaging. averagingNumMin = 1 # Minimum number of points in averaging. Must be ≥ 1. averagingPercentile = 0 # Percentile value for which data values to include in averaging. 0.0 means off. extrapolationMethod = 0 # Option for (spatial) extrapolation. diff --git a/examples/dflowfm_local/dflowfm/fm_net.nc b/examples/dflowfm_local/dflowfm/fm_net.nc index 92d90f8d8dacd0cb732c20dc07bad7ee79ccf022..c64bdbdadaa12972be97f68de6ba0a5ff8eda9dd 100644 GIT binary patch delta 36 rcmbQUoO8}{&JBu8yq3C#rV56JRwgD^CWg&=OznD1jNA2?nDPPvyHp7q delta 36 rcmbQUoO8}{&JBu8ycW8Kh6;veR>r1QMyAbrOznD1jNA2?nDPPvyITnz diff --git a/examples/dflowfm_local/dimr_config.xml b/examples/dflowfm_local/dimr_config.xml index 206c4a54..247788a8 100644 --- a/examples/dflowfm_local/dimr_config.xml +++ b/examples/dflowfm_local/dimr_config.xml @@ -3,7 +3,7 @@ 1.3 hydrolib-core 0.5.2 - 2023-08-11T14:35:18.164371 + 2023-09-15T09:44:33.148012 diff --git a/examples/dflowfm_local/geoms/bridges.geojson b/examples/dflowfm_local/geoms/bridges.geojson index c6c80d50..490c5cce 100644 --- a/examples/dflowfm_local/geoms/bridges.geojson +++ b/examples/dflowfm_local/geoms/bridges.geojson @@ -2,7 +2,7 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -{ "type": "Feature", "properties": { "formfactor": null, "frictiontype": "Manning", "id": "bridge_1", "outletlosscoeff": 0.2, "pillarwidth": null, "type": "bridge", "inletlosscoeff": 0.2, "branchid": "branch_12", "friction": 0.023, "csdefid": "rect_h1.550_w2.000_cno_point", "chainage": 14.101, "length": 10.0, "shift": 2.34, "allowedflowdir": "positive" }, "geometry": { "type": "Point", "coordinates": [ 665021.849053248995915, 1525588.928306785644963 ] } }, -{ "type": "Feature", "properties": { "formfactor": null, "frictiontype": "Manning", "id": "bridge_2", "outletlosscoeff": 0.82, "pillarwidth": null, "type": "bridge", "inletlosscoeff": 0.8, "branchid": "branch_3", "friction": 0.023, "csdefid": "rect_h1.800_w5.000_cyes_point", "chainage": 485.794, "length": 5.0, "shift": 2.37, "allowedflowdir": "both" }, "geometry": { "type": "Point", "coordinates": [ 665599.689329552114941, 1525859.454655284294859 ] } } +{ "type": "Feature", "properties": { "branchid": "branch_12", "csdefid": "rect_h1.550_w2.000_cno_point", "friction": 0.023, "id": "bridge_1", "allowedflowdir": "positive", "outletlosscoeff": 0.2, "type": "bridge", "inletlosscoeff": 0.2, "chainage": 14.101, "length": 10.0, "shift": 2.34, "formfactor": null, "frictiontype": "Manning", "pillarwidth": null }, "geometry": { "type": "Point", "coordinates": [ 665021.849053248995915, 1525588.928306785644963 ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_3", "csdefid": "rect_h1.800_w5.000_cyes_point", "friction": 0.023, "id": "bridge_2", "allowedflowdir": "both", "outletlosscoeff": 0.82, "type": "bridge", "inletlosscoeff": 0.8, "chainage": 485.794, "length": 5.0, "shift": 2.37, "formfactor": null, "frictiontype": "Manning", "pillarwidth": null }, "geometry": { "type": "Point", "coordinates": [ 665599.689329552114941, 1525859.454655284294859 ] } } ] } diff --git a/examples/dflowfm_local/geoms/culverts.geojson b/examples/dflowfm_local/geoms/culverts.geojson index f521098e..3ba6c28a 100644 --- a/examples/dflowfm_local/geoms/culverts.geojson +++ b/examples/dflowfm_local/geoms/culverts.geojson @@ -2,6 +2,6 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -{ "type": "Feature", "properties": { "outletlosscoeff": 0.2, "type": "culvert", "csdefid": "rect_h1.500_w1.500_cyes_point", "valveonoff": 0.0, "valveopeningheight": null, "bedfriction": 0.012, "relopening": null, "numlosscoeff": null, "allowedflowdir": "positive", "leftlevel": 2.56, "id": "culvert_1", "losscoeff": null, "inletlosscoeff": 0.2, "branchid": "branch_13", "chainage": 331.832, "length": 1.0, "rightlevel": 2.5, "bedfrictiontype": "Manning" }, "geometry": { "type": "Point", "coordinates": [ 665186.754018069244921, 1525896.07843215460889 ] } } +{ "type": "Feature", "properties": { "bedfriction": 0.012, "id": "culvert_1", "outletlosscoeff": 0.2, "type": "culvert", "valveopeningheight": null, "losscoeff": null, "length": 1.0, "numlosscoeff": null, "valveonoff": 0.0, "branchid": "branch_13", "leftlevel": 2.56, "csdefid": "rect_h1.500_w1.500_cyes_point", "allowedflowdir": "positive", "relopening": null, "inletlosscoeff": 0.2, "chainage": 331.832, "bedfrictiontype": "Manning", "rightlevel": 2.5 }, "geometry": { "type": "Point", "coordinates": [ 665186.754018069244921, 1525896.07843215460889 ] } } ] } diff --git a/hydromt_delft3dfm/dflowfm.py b/hydromt_delft3dfm/dflowfm.py index 33c482ed..b16d77c4 100644 --- a/hydromt_delft3dfm/dflowfm.py +++ b/hydromt_delft3dfm/dflowfm.py @@ -1681,84 +1681,54 @@ def _read_laterals(self, laterals_geodataset_fn): def setup_1dlateral_from_points( self, laterals_geodataset_fn: str = None, - lateral_value: float = -2.5, - branch_type: str = "river", + lateral_value: float = 0.0, snap_offset: float = 1.0, + branch_type: str = "river", ): """ - Prepares the 1D lateral discharge for a certain `branch_type`. - E.g. '1' m3/s for all lateral locations on the 'river' branches. + Prepares the 1D lateral discharge from geodataset of point geometries. + E.g. '1' m3/s for all lateral locations. + + Use ``laterals_geodataset_fn`` to set the lateral values from a geodataset + of point locations. + Support also geodataframe of point locations in combination of `lateral_value`. - Use ``lateral_fn`` to set the lateral values from a geodataframe of point locations. Only locations that are snapped to the network of `branch_type` within a max distance defined in ``snap_offset`` are used. The discharge can either be a constant using ``lateral_value`` (default) or - a timeseries read from ``laterals_timeseries_fn``. - If ``laterals_timeseries_fn`` has missing values, the constant ``lateral_value`` will be used. + a timeseries read from ``laterals_geodataset_fn``. + If the timeseries has missing values, the constant ``lateral_value`` will be used. The timeseries are clipped to the model time based on the model config tstart and tstop entries. Adds/Updates model layers: - * ** lateral_discharge_{branch_type}** forcing: 1D laterals DataArray + * ** lateral1d_points** forcing: 1D laterals DataArray with points coordinates. Parameters ---------- laterals_geodataset_fn : str, Path Path or data source name for geospatial point location file. - * Required variables if a combined point location file: ['index'] with type int - * Required variables ['laterals_discharge'] - laterals_timeseries_fn: str, Path - Path to tabulated timeseries csv file with time index in first column - and location IDs in the first row, - see :py:meth:`hydromt.open_timeseries_from_table`, for details. - NOTE: tabulated timeseries files can only in combination with point location - coordinates be set as a geodataset in the data_catalog yml file. + * Required variables if geodataset is provided ['laterals_discharge'] NOTE: Require equidistant time series lateral_value : float, optional - Constant value to use for all laterals if ``laterals_timeseries_fn`` is None and to - fill in missing data. By default 0 [m3/s]. - branch_type: str - Type of branch to apply boundaries on. One of ["river", "pipe"]. + Constant value to use for all laterals if ``laterals_geodataset_fn`` is a geodataframe, + or for filling in missing data. + By default 0 [m3/s]. snap_offset : float, optional - Snapping tolerance to automatically applying boundaries at the correct network nodes. + Snapping tolerance to automatically applying boundaries at the correct network nodes. By default 0.1, a small snapping is applied to avoid precision errors. + branch_type: str, optional + Type of branch to apply laterals on. One of ["river", "pipe"]. + If None, all branches are used. + By defalt None. """ self.logger.info(f"Preparing 1D laterals for {branch_type}.") network_by_branchtype = self.staticgeoms[f"{branch_type}s"] - refdate, tstart, tstop = self.get_model_time() # time slice - # 1. read lateral geodataset - # FIXME what if I only have geodataframe? - if laterals_geodataset_fn is not None: - da_bnd = self.data_catalog.get_geodataset( - laterals_geodataset_fn, - geom=self.region.buffer( - self._network_snap_offset - ), # only select data within region of interest - variables=["lateral_discharge"], - time_tuple=(tstart, tstop), - crs=self.crs.to_epsg(), # assume model crs if none defined - ).rename("lateral_discharge") - # error if time mismatch - if np.logical_and( - pd.to_datetime(da_bnd.time.values[0]) == pd.to_datetime(tstart), - pd.to_datetime(da_bnd.time.values[-1]) == pd.to_datetime(tstop), - ): - pass - else: - self.logger.error( - "forcing has different start and end time. Please check the forcing file. support yyyy-mm-dd HH:MM:SS. " - ) - # reproject if needed and convert to location - if da_bnd.vector.crs != self.crs: - da_bnd.vector.to_crs(self.crs) - # get geom - gdf_laterals = da_bnd.vector.to_gdf(reducer=np.mean) - else: - da_bnd = None # FIXME - gdf_laterals = None + # 1. read lateral geodataset and snap to network + gdf_laterals, da_lat = self._read_laterals(laterals_geodataset_fn) # snap laterlas to selected branches workflows.find_nearest_branch( @@ -1770,16 +1740,15 @@ def setup_1dlateral_from_points( columns={"branch_id": "branchid", "branch_offset": "chainage"} ) - # 3. Derive lateral dataarray - da_out = workflows.compute_forcing_values( # points + # 2. Compute lateral dataarray + da_out = workflows.compute_forcing_values_points( gdf=gdf_laterals, - da=da_bnd, + da=da_lat, forcing_value=lateral_value, forcing_type="lateral_discharge", forcing_unit="m3/s", logger=self.logger, ) - # TODO: the polygon is supported by delft3dfm lateral, no convertion to points needed # 4. set boundaries self.set_forcing(da_out, name=f"lateral1d_points") @@ -1790,38 +1759,40 @@ def setup_1dlateral_from_polygons( lateral_value: float = -2.5, ): """ - Prepares the 1D lateral discharge within a polygon. - E.g. '1' m3/s for all lateral polygons. + Prepares the 1D lateral discharge from geodataset of polygons. + E.g. '1' m3/s for all lateral locations. - Use ``laterals_geodataset_fn`` to set the lateral values from a geodatasets containing of polygons and (optionaly) timeseries. + Use ``laterals_geodataset_fn`` to set the lateral values from a geodatasets + of polygons. + Support also geodataframe of polygons in combination of `lateral_value`. The discharge can either be a constant using ``lateral_value`` (default) or a timeseries read from ``laterals_geodataset_fn``. - If ``laterals_geodataset_fn`` has missing values, the constant ``lateral_value`` will be used. + If the timeseries has missing values, the constant ``lateral_value`` will be used. The timeseries are clipped to the model time based on the model config tstart and tstop entries. Adds/Updates model layers: - * ** lateral1d_polygon** forcing: 1D laterals DataArray + * ** lateral1d_polygons** forcing: 1D laterals DataArray with polygon coordinates. Parameters ---------- laterals_geodataset_fn : str, Path Path or data source name for geospatial point location file. - * Required variables if a combined point location file: ['index'] with type int - * Required variables ['laterals_discharge'] + * Required variables if geodataset is provided ['laterals_discharge'] + NOTE: Require equidistant time series lateral_value : float, optional - Constant value to use for all laterals if ``laterals_timeseries_fn`` is None and to - fill in missing data. By default 0 [m3/s]. + Constant value to use for all laterals if ``laterals_geodataset_fn`` is a geodataframe, + or for filling in missing data. + By default 0 [m3/s]. """ self.logger.info(f"Preparing 1D laterals for polygons.") # 1. read lateral geodataset - # FIXME what if I only have geodataframe? gdf_laterals, da_lat = self._read_laterals(laterals_geodataset_fn) - # 2. Derive lateral dataarray + # 2. Compute lateral dataarray da_out = workflows.compute_forcing_values_polygon( gdf=gdf_laterals, da=da_lat, @@ -1831,7 +1802,7 @@ def setup_1dlateral_from_polygons( logger=self.logger, ) - # 3. set boundaries + # 3. set laterals self.set_forcing(da_out, name=f"lateral1d_polygons") def _setup_1dstructures( diff --git a/hydromt_delft3dfm/utils.py b/hydromt_delft3dfm/utils.py index a86ec34f..660f034c 100644 --- a/hydromt_delft3dfm/utils.py +++ b/hydromt_delft3dfm/utils.py @@ -750,6 +750,7 @@ def read_1dlateral( Name of quantity. Supports only "lateral_discharge". nodes: gpd.GeoDataFrame Nodes locations of the laterals in df. + # not implemented branches: gpd.GeoDataFrame Branches on which the laterals in df are located. diff --git a/hydromt_delft3dfm/workflows/boundaries.py b/hydromt_delft3dfm/workflows/boundaries.py index 714f14d7..560e2db3 100644 --- a/hydromt_delft3dfm/workflows/boundaries.py +++ b/hydromt_delft3dfm/workflows/boundaries.py @@ -23,7 +23,7 @@ "compute_boundary_values", "compute_2dboundary_values", "compute_meteo_forcings", - "compute_forcing_values", + "compute_forcing_values_points", "compute_forcing_values_polygon", "get_geometry_coords_for_polygons", ] @@ -610,67 +610,81 @@ def compute_meteo_forcings( return da_out -def compute_forcing_values( +def _standardize_forcing_timeindexes(da): + """Standardize timeindexes frequency based on forcing DataArray""" + _TIMESTR = {"D": "days", "H": "hours", "T": "minutes", "S": "seconds"} + dt = pd.to_timedelta((da.time[1].values - da.time[0].values)) + freq = dt.resolution_string + multiplier = 1 + if freq == "D": + logger.warning( + "time unit days is not supported by the current GUI version: 2022.04" + ) # converting to hours as temporary solution # FIXME: day is converted to hours temporarily + multiplier = 24 + if len(pd.date_range(da.time[0].values, da.time[-1].values, freq=dt)) != len( + da.time + ): + logger.error("does not support non-equidistant time-series.") + freq_name = _TIMESTR[freq] + freq_step = getattr(dt.components, freq_name) + bd_times = np.array([(i * freq_step) for i in range(len(da.time))]) + if multiplier == 24: + bd_times = np.array([(i * freq_step * multiplier) for i in range(len(da.time))]) + freq_name = "hours" + return bd_times, freq_name + + +def compute_forcing_values_points( gdf: gpd.GeoDataFrame, da: xr.DataArray = None, - forcing_value: float = -2.5, - forcing_type: str = "waterlevelbnd", - forcing_unit: str = "m", + forcing_value: float = 0.0, + forcing_type: str = "lateral_discharge", + forcing_unit: str = "m3/s", logger=logger, ): """ - Compute 1d forcing values. Used for 1D lateral point locations. - # TODO harmonize for all 1D forcings (boundary + laterals) + Compute 1d forcing values. + + Used for 1D lateral point locations. Parameters ---------- gdf : gpd.GeoDataFrame - Point locations of the 1D forcings to which to add data. + GeoDataFrame of points to add 1D forcing data. - * Required variables: ['branchid', 'chainage'] + * Required variables: ['geometry'] da : xr.DataArray, optional - xr.DataArray containing the forcing timeseries values. If None, uses a constant values for all forcings. + xr.DataArray containing the forcing timeseries values. + If None, uses a constant ``forcing_value`` for all forcings. - * Required variables: [``forcing_type``] + * Required variables: ['forcing_type'] forcing_value : float, optional Constant value to use for all forcings if ``da`` is None and to fill in missing data. + By default 0.0 ``forcing_unit`` forcing_type : {'lateral_discharge'} Type of forcing to use. + For now only support 'lateral_discharge'. + By default 'lateral_discharge' forcing_unit : {'m3/s'} - Unit corresponding to [forcing_type]. + Unit corresponding to ``forcing_type``. + By default 'm3/s' logger Logger to log messages. """ - # Timeseries boundary values + # TODO: harmonize for other point forcing #21 + # first process data based on either timeseries or constant + # then update data based on either nodes or branches + # Timeseries forcing values if da is not None: logger.info(f"Preparing 1D forcing type {forcing_type} from timeseries.") - # get boundary data freq in seconds - _TIMESTR = {"D": "days", "H": "hours", "T": "minutes", "S": "seconds"} - dt = pd.to_timedelta((da.time[1].values - da.time[0].values)) - freq = dt.resolution_string - multiplier = 1 - if freq == "D": - logger.warning( - "time unit days is not supported by the current GUI version: 2022.04" - ) # converting to hours as temporary solution # FIXME: day is converted to hours temporarily - multiplier = 24 - if len(pd.date_range(da.time[0].values, da.time[-1].values, freq=dt)) != len( - da.time - ): - logger.error("does not support non-equidistant time-series.") - freq_name = _TIMESTR[freq] - freq_step = getattr(dt.components, freq_name) - bd_times = np.array([(i * freq_step) for i in range(len(da.time))]) - if multiplier == 24: - bd_times = np.array( - [(i * freq_step * multiplier) for i in range(len(da.time))] - ) - freq_name = "hours" + # get forcing data freq in seconds + bd_times, freq_name = _standardize_forcing_timeindexes(da) - # instantiate xr.DataArray for bnd data + # instantiate xr.DataArray for forcing data + # NOTE only support points on branches da_out = xr.DataArray( data=da.data, dims=["index", "time"], @@ -727,7 +741,7 @@ def compute_forcing_values( def get_geometry_coords_for_polygons(gdf): - """Gets static coordinates from polygon inputs. + """Gets xarray DataArray coordinates that describes polygon geometries. Inlcudes numcoordinates, xcoordinates and ycoordinates""" if gdf.geometry.type.iloc[0] == "Polygon": # Get the maximum number of coordinates for any polygon @@ -766,63 +780,50 @@ def get_ycoords(geom): def compute_forcing_values_polygon( gdf: gpd.GeoDataFrame, da: xr.DataArray = None, - forcing_value: float = -2.5, + forcing_value: float = 0.0, forcing_type: str = "waterlevelbnd", forcing_unit: str = "m", logger=logger, ): """ - Compute 1d forcing values. Used for 1D lateral polygon locations. + Compute 1d forcing values. + + Used for 1D lateral polygon locations. Parameters ---------- gdf : gpd.GeoDataFrame - Point locations of the 1D forcings to which to add data. + GeoDataFrame of polygons to add 1D forcing data. * Required variables: ['geometry'] da : xr.DataArray, optional - xr.DataArray containing the forcing timeseries values. If None, uses a constant values for all forcings. + xr.DataArray containing the forcing timeseries values. + If None, uses a constant ``forcing_value`` for all forcings. - * Required variables: [``forcing_type``] + * Required variables: ['forcing_type'] forcing_value : float, optional Constant value to use for all forcings if ``da`` is None and to fill in missing data. + By default 0.0 ``forcing_unit`` forcing_type : {'lateral_discharge'} Type of forcing to use. + For now only support 'lateral_discharge'. + By default 'lateral_discharge' forcing_unit : {'m3/s'} - Unit corresponding to [forcing_type]. + Unit corresponding to ``forcing_type``. + By default 'm3/s' logger Logger to log messages. """ - # Timeseries boundary values + # Timeseries forcing values if da is not None: logger.info(f"Preparing 1D forcing type {forcing_type} from timeseries.") - # get boundary data freq in seconds - _TIMESTR = {"D": "days", "H": "hours", "T": "minutes", "S": "seconds"} - dt = pd.to_timedelta((da.time[1].values - da.time[0].values)) - freq = dt.resolution_string - multiplier = 1 - if freq == "D": - logger.warning( - "time unit days is not supported by the current GUI version: 2022.04" - ) # converting to hours as temporary solution # FIXME: day is converted to hours temporarily - multiplier = 24 - if len(pd.date_range(da.time[0].values, da.time[-1].values, freq=dt)) != len( - da.time - ): - logger.error("does not support non-equidistant time-series.") - freq_name = _TIMESTR[freq] - freq_step = getattr(dt.components, freq_name) - bd_times = np.array([(i * freq_step) for i in range(len(da.time))]) - if multiplier == 24: - bd_times = np.array( - [(i * freq_step * multiplier) for i in range(len(da.time))] - ) - freq_name = "hours" + # get forcing data time indes + bd_times, freq_name = _standardize_forcing_timeindexes(da) - # instantiate xr.Dataset for bnd data + # instantiate xr.DataArray for forcing data coords_dict = get_geometry_coords_for_polygons(gdf) # Prepare the data data_3d = np.tile( @@ -859,7 +860,7 @@ def compute_forcing_values_polygon( logger.info( f"Using constant value {forcing_value} {forcing_unit} for all {forcing_type} forcings." ) - # instantiate xr.DataSet for bnd data with forcing_type directly + # instantiate xr.DataArray for forcing data with forcing_type directly coords_dict = get_geometry_coords_for_polygons(gdf) data_3d = np.full( (len(coords_dict["index"]), len(coords_dict["numcoordinates"])), diff --git a/tests/data/dflowfm_build_local.yml b/tests/data/dflowfm_build_local.yml index 1b8b875e..a55a823c 100644 --- a/tests/data/dflowfm_build_local.yml +++ b/tests/data/dflowfm_build_local.yml @@ -42,6 +42,16 @@ setup_1dboundary: boundary_unit: m boundary_locs: both +setup_1dlateral_from_points: + laterals_geodataset_fn: 1D_laterals_timeseries + branch_type: river + snap_offset: 10 + lateral_value: 0 + +setup_1dlateral_from_polygons: + laterals_geodataset_fn: 1D_laterals_polygons_timeseries + lateral_value: 0 + setup_mesh2d: region: geom: "local_data/1D_extent.geojson" diff --git a/tests/data/local_data/laterals_series.csv b/tests/data/local_data/laterals_series.csv index 45d45272..bfdeba74 100644 --- a/tests/data/local_data/laterals_series.csv +++ b/tests/data/local_data/laterals_series.csv @@ -1,26 +1,26 @@ -datetime,0,1 -2020-1-1 00:00,-1,0 -2020-1-1 01:00,-1,0 -2020-1-1 02:00,-1,0 -2020-1-1 03:00,-1,0 -2020-1-1 04:00,-1,0 -2020-1-1 05:00,-1,0 -2020-1-1 06:00,-1,0 -2020-1-1 07:00,-1,0 -2020-1-1 08:00,-1,0 -2020-1-1 09:00,-1,0 -2020-1-1 10:00,-1,0 -2020-1-1 11:00,-1,0 -2020-1-1 12:00,-1,0 -2020-1-1 13:00,-1,0 -2020-1-1 14:00,-1,0 -2020-1-1 15:00,-1,0 -2020-1-1 16:00,-1,0 -2020-1-1 17:00,-1,0 -2020-1-1 18:00,-1,0 -2020-1-1 19:00,-1,0 -2020-1-1 20:00,-1,0 -2020-1-1 21:00,-1,0 -2020-1-1 22:00,-1,0 -2020-1-1 23:00,-1,0 -2020-1-2 00:00,-1,0 +datetime,0 +2020-1-1 00:00,0 +2020-1-1 01:00,0 +2020-1-1 02:00,0 +2020-1-1 03:00,0 +2020-1-1 04:00,0 +2020-1-1 05:00,0 +2020-1-1 06:00,0 +2020-1-1 07:00,0 +2020-1-1 08:00,0 +2020-1-1 09:00,0 +2020-1-1 10:00,0 +2020-1-1 11:00,0 +2020-1-1 12:00,0 +2020-1-1 13:00,0 +2020-1-1 14:00,0 +2020-1-1 15:00,0 +2020-1-1 16:00,0 +2020-1-1 17:00,0 +2020-1-1 18:00,0 +2020-1-1 19:00,0 +2020-1-1 20:00,0 +2020-1-1 21:00,0 +2020-1-1 22:00,0 +2020-1-1 23:00,0 +2020-1-2 00:00,0 diff --git a/tests/data/test_data.yaml b/tests/data/test_data.yaml index 9a47da00..81aba620 100644 --- a/tests/data/test_data.yaml +++ b/tests/data/test_data.yaml @@ -93,6 +93,21 @@ 1D_laterals_timeseries: lateral_discharge kwargs: fn_data: local_data/laterals_series.csv +1D_laterals_polygons: + data_type: GeoDataFrame + driver: vector + path: local_data/laterals_polygons.geojson + crs: 32647 +1D_laterals_polygons_timeseries: + path: local_data/laterals_polygons.geojson + data_type: GeoDataset + driver: vector + crs: 32647 + rename: + 1D_laterals_polygons_timeseries: lateral_discharge + kwargs: + fn_data: local_data/laterals_series.csv + assert_gtype: Polygon roads: path: local_data/roads.tiff data_type: RasterDataset From 1db751f45617ad48e53f35c4d9ad83b8a03648af Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Fri, 15 Sep 2023 12:21:48 +0200 Subject: [PATCH 04/32] bug fixing --- .../dflowfm/lateral1d_discharge.bc | 78 +++++++++++++++++++ hydromt_delft3dfm/utils.py | 35 +++++---- hydromt_delft3dfm/workflows/boundaries.py | 4 +- 3 files changed, 101 insertions(+), 16 deletions(-) create mode 100644 examples/dflowfm_local/dflowfm/lateral1d_discharge.bc diff --git a/examples/dflowfm_local/dflowfm/lateral1d_discharge.bc b/examples/dflowfm_local/dflowfm/lateral1d_discharge.bc new file mode 100644 index 00000000..878e7577 --- /dev/null +++ b/examples/dflowfm_local/dflowfm/lateral1d_discharge.bc @@ -0,0 +1,78 @@ +# written by HYDROLIB-core 0.5.2 + +[General] +fileVersion = 1.01 +fileType = boundConds + +[Forcing] +name = lateral1d_points_0 +function = timeseries +timeInterpolation = linear +offset = 0.0 +factor = 1.0 +quantity = time +unit = hours since 2020-01-01 00:00:00 +quantity = lateral_discharge +unit = m3/s +0.0 0.0 +1.0 0.0 +2.0 0.0 +3.0 0.0 +4.0 0.0 +5.0 0.0 +6.0 0.0 +7.0 0.0 +8.0 0.0 +9.0 0.0 +10.0 0.0 +11.0 0.0 +12.0 0.0 +13.0 0.0 +14.0 0.0 +15.0 0.0 +16.0 0.0 +17.0 0.0 +18.0 0.0 +19.0 0.0 +20.0 0.0 +21.0 0.0 +22.0 0.0 +23.0 0.0 +24.0 0.0 + +[Forcing] +name = lateral1d_polygons_0 +function = timeseries +timeInterpolation = linear +offset = 0.0 +factor = 1.0 +quantity = time +unit = hours since 2020-01-01 00:00:00 +quantity = lateral_discharge +unit = m3/s +0.0 0.0 +1.0 0.0 +2.0 0.0 +3.0 0.0 +4.0 0.0 +5.0 0.0 +6.0 0.0 +7.0 0.0 +8.0 0.0 +9.0 0.0 +10.0 0.0 +11.0 0.0 +12.0 0.0 +13.0 0.0 +14.0 0.0 +15.0 0.0 +16.0 0.0 +17.0 0.0 +18.0 0.0 +19.0 0.0 +20.0 0.0 +21.0 0.0 +22.0 0.0 +23.0 0.0 +24.0 0.0 + diff --git a/hydromt_delft3dfm/utils.py b/hydromt_delft3dfm/utils.py index 660f034c..3615b789 100644 --- a/hydromt_delft3dfm/utils.py +++ b/hydromt_delft3dfm/utils.py @@ -810,20 +810,24 @@ def read_1dlateral( # Get lateral locations and update dimentions and coordinates if any(df.numcoordinates.values): # polygons - df["geometry"] = df.apply( + _df = df[~df.numcoordinates.isna()] + _data = data[~df.numcoordinates.isna()] + # Update coords + _df["geometry"] = _df.apply( lambda row: Polygon(zip(row["xcoordinates"], row["ycoordinates"])), axis=1 ) - coords_dict = boundaries.get_geometry_coords_for_polygons(gpd.GeoDataFrame(df)) + coords_dict = boundaries.get_geometry_coords_for_polygons(gpd.GeoDataFrame(_df)) + dims.append("numcoordinates") + coords.update(coords_dict) # Updates the data - data = np.tile( - np.expand_dims(data, axis=-1), + _data = np.tile( + np.expand_dims(_data, axis=-1), (1, 1, len(coords_dict["numcoordinates"])), ) - dims.append("numcoordinates") - coords.update(coords_dict) + # Prep DataArray and add to forcing da_out = xr.DataArray( - data=data, + data=_data, dims=dims, coords=coords, attrs=bc, @@ -835,20 +839,23 @@ def read_1dlateral( # TODO laterals on nodes #78 pass elif any(df.branchid.values): - branchids = df.branchid.values - branchids = branchids[branchids != "nan"] - df["geometry"] = [ + _df = df[~df.branchid.isna()] + _data = data[~df.numcoordinates.isna()] + # update coords + _df["geometry"] = [ branches.set_index("branchid") .loc[i.branchid, "geometry"] .interpolate(i.chainage) - for i in df.itertuples() + for i in _df.itertuples() ] # Updates the data - coords["x"] = ("index", np.array(df.geometry.x)) - coords["y"] = ("index", np.array(df.geometry.y)) + coords["x"] = ("index", np.array([p.x for p in _df["geometry"].values])) + coords["y"] = ("index", np.array([p.y for p in _df["geometry"].values])) + coords["branchid"] = ("index", _df["branchid"].values) + coords["chainage"] = ("index", _df["chainage"].values) # Prep DataArray and add to forcing da_out = xr.DataArray( - data=data, + data=_data, dims=dims, coords=coords, attrs=bc, diff --git a/hydromt_delft3dfm/workflows/boundaries.py b/hydromt_delft3dfm/workflows/boundaries.py index 560e2db3..0fb7129d 100644 --- a/hydromt_delft3dfm/workflows/boundaries.py +++ b/hydromt_delft3dfm/workflows/boundaries.py @@ -827,12 +827,12 @@ def compute_forcing_values_polygon( coords_dict = get_geometry_coords_for_polygons(gdf) # Prepare the data data_3d = np.tile( - np.expand_dims(da.data, axis=1), (1, len(coords_dict["numcoordinates"]), 1) + np.expand_dims(da.data, axis=-1), (1, 1, len(coords_dict["numcoordinates"])) ) # Create the DataArray da_out = xr.DataArray( data=data_3d, - dims=("index", "numcoordinates", "time"), + dims=("index", "time", "numcoordinates"), coords={ "index": coords_dict["index"], "numcoordinates": coords_dict["numcoordinates"], From 5065c6a5c8bbf8c8b5e95d0bd0de2f5afcb8111e Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Fri, 15 Sep 2023 12:22:05 +0200 Subject: [PATCH 05/32] update example --- examples/dflowfm_local/dflowfm/fm_net.nc | Bin 152476 -> 152476 bytes examples/dflowfm_local/dimr_config.xml | 2 +- .../dflowfm_local/geoms/boundaries.geojson | 24 ++++---- examples/dflowfm_local/geoms/branches.geojson | 56 +++++++++--------- examples/dflowfm_local/geoms/bridges.geojson | 4 +- examples/dflowfm_local/geoms/culverts.geojson | 2 +- examples/dflowfm_local/geoms/manholes.geojson | 28 ++++----- .../dflowfm_local/geoms/pipe_nodes.geojson | 40 ++++++------- examples/dflowfm_local/geoms/pipes.geojson | 28 ++++----- examples/dflowfm_local/geoms/rivers.geojson | 28 ++++----- .../dflowfm_local/geoms/rivers_nodes.geojson | 34 +++++------ 11 files changed, 123 insertions(+), 123 deletions(-) diff --git a/examples/dflowfm_local/dflowfm/fm_net.nc b/examples/dflowfm_local/dflowfm/fm_net.nc index c64bdbdadaa12972be97f68de6ba0a5ff8eda9dd..b52b6be76eb2be4a7b3e1b5a1793273d3048c1f1 100644 GIT binary patch delta 30 kcmbQUoO8}{&JF5J>_%1wmO#|3$JDOJ#JF9Li777-0F00b1ONa4 delta 30 lcmbQUoO8}{&JF5J?1ok*CRQef&3a7jdQ6Pl^_ZCQ0s)LW2mSy6 diff --git a/examples/dflowfm_local/dimr_config.xml b/examples/dflowfm_local/dimr_config.xml index 247788a8..eea0ab4e 100644 --- a/examples/dflowfm_local/dimr_config.xml +++ b/examples/dflowfm_local/dimr_config.xml @@ -3,7 +3,7 @@ 1.3 hydrolib-core 0.5.2 - 2023-09-15T09:44:33.148012 + 2023-09-15T10:09:00.249442 diff --git a/examples/dflowfm_local/geoms/boundaries.geojson b/examples/dflowfm_local/geoms/boundaries.geojson index 931af5aa..67965256 100644 --- a/examples/dflowfm_local/geoms/boundaries.geojson +++ b/examples/dflowfm_local/geoms/boundaries.geojson @@ -2,17 +2,17 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -{ "type": "Feature", "properties": { "level_0": 662793.79418679164, "level_1": 1524515.4517321615, "branchid": "river_1", "branchtype": "river", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_1", "frictionid": "Manning_0.023", "diameter": null, "index_right": 1, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "where": "downstream", "distance_right": 2.6354886210617495e-07, "nodeid": "662793.794187_1524515.451732" }, "geometry": { "type": "Point", "coordinates": [ 662793.794186791637912, 1524515.451732161454856 ] } }, -{ "type": "Feature", "properties": { "level_0": 664197.23415962339, "level_1": 1527152.7059848213, "branchid": "river_2", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_2", "frictionid": "Manning_0.023", "diameter": null, "index_right": 2, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "where": "downstream", "distance_right": 4.1679906021887385e-07, "nodeid": "664197.234160_1527152.705985" }, "geometry": { "type": "Point", "coordinates": [ 664197.234159623389132, 1527152.705984821310267 ] } }, -{ "type": "Feature", "properties": { "level_0": 666180.04, "level_1": 1525894.77, "branchid": "branch_8", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_8", "frictionid": "Manning_0.023", "diameter": null, "index_right": 10, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "where": "upstream", "distance_right": 6.9849193096160889e-10, "nodeid": "666180.040000_1525894.770000" }, "geometry": { "type": "Point", "coordinates": [ 666180.040000000037253, 1525894.769999999320135 ] } }, -{ "type": "Feature", "properties": { "level_0": 664789.14617260336, "level_1": 1525073.3461271923, "branchid": "branch_11", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_11", "frictionid": "Manning_0.023", "diameter": null, "index_right": 12, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "where": "upstream", "distance_right": 4.4079386833570057e-07, "nodeid": "664789.146173_1525073.346127" }, "geometry": { "type": "Point", "coordinates": [ 664789.146172603359446, 1525073.346127192256972 ] } }, -{ "type": "Feature", "properties": { "level_0": 664190.38579999981, "level_1": 1525924.0326000003, "branchid": "pipe_5", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_5", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 16, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 3.2927225399135965e-10, "nodeid": "664190.385800_1525924.032600" }, "geometry": { "type": "Point", "coordinates": [ 664190.385799999814481, 1525924.032600000267848 ] } }, -{ "type": "Feature", "properties": { "level_0": 664048.32531966059, "level_1": 1525098.0711124309, "branchid": "pipe_9", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 20, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 5.4853769327396927e-07, "nodeid": "664048.325320_1525098.071112" }, "geometry": { "type": "Point", "coordinates": [ 664048.325319660594687, 1525098.071112430887297 ] } }, -{ "type": "Feature", "properties": { "level_0": 664702.72692603013, "level_1": 1525750.0985501537, "branchid": "pipe_10", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 21, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 1.5659834095829541e-07, "nodeid": "664702.726926_1525750.098550" }, "geometry": { "type": "Point", "coordinates": [ 664702.726926030125469, 1525750.098550153663382 ] } }, -{ "type": "Feature", "properties": { "level_0": 664747.43349663052, "level_1": 1525729.6497995616, "branchid": "pipe_12", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 23, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 5.7336208882836857e-07, "nodeid": "664747.433497_1525729.649800" }, "geometry": { "type": "Point", "coordinates": [ 664747.433496630517766, 1525729.649799561593682 ] } }, -{ "type": "Feature", "properties": { "level_0": 665219.64311349345, "level_1": 1525514.959856804, "branchid": "pipe_14", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_14", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 25, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 5.3099907323260637e-07, "nodeid": "665219.643113_1525514.959857" }, "geometry": { "type": "Point", "coordinates": [ 665219.643113493453711, 1525514.959856803994626 ] } }, -{ "type": "Feature", "properties": { "level_0": 664708.73862075247, "level_1": 1524483.1447981687, "branchid": "pipe_15", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_15", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 26, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 2.9945179934390397e-07, "nodeid": "664708.738621_1524483.144798" }, "geometry": { "type": "Point", "coordinates": [ 664708.738620752468705, 1524483.144798168679699 ] } }, -{ "type": "Feature", "properties": { "level_0": 665277.57411764679, "level_1": 1525446.3931947846, "branchid": "pipe_16", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_16", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 27, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 4.136866578190493e-07, "nodeid": "665277.574118_1525446.393195" }, "geometry": { "type": "Point", "coordinates": [ 665277.574117646785453, 1525446.393194784643129 ] } }, -{ "type": "Feature", "properties": { "level_0": 665292.61532070651, "level_1": 1525470.8495163794, "branchid": "pipe_17", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_17", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 28, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 4.7975319107342047e-07, "nodeid": "665292.615321_1525470.849516" }, "geometry": { "type": "Point", "coordinates": [ 665292.615320706507191, 1525470.849516379414126 ] } } +{ "type": "Feature", "properties": { "level_0": 662793.79418679164, "level_1": 1524515.4517321615, "branchtype": "river", "branchid": "river_1", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_1", "frictionid": "Manning_0.023", "diameter": null, "index_right": 1, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "where": "downstream", "distance_right": 2.6354886210617495e-07, "nodeid": "662793.794187_1524515.451732" }, "geometry": { "type": "Point", "coordinates": [ 662793.794186791637912, 1524515.451732161454856 ] } }, +{ "type": "Feature", "properties": { "level_0": 664197.23415962339, "level_1": 1527152.7059848213, "branchtype": "river", "branchid": "river_2", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_2", "frictionid": "Manning_0.023", "diameter": null, "index_right": 2, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "where": "downstream", "distance_right": 4.1679906021887385e-07, "nodeid": "664197.234160_1527152.705985" }, "geometry": { "type": "Point", "coordinates": [ 664197.234159623389132, 1527152.705984821310267 ] } }, +{ "type": "Feature", "properties": { "level_0": 666180.04, "level_1": 1525894.77, "branchtype": "river", "branchid": "branch_8", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_8", "frictionid": "Manning_0.023", "diameter": null, "index_right": 10, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "where": "upstream", "distance_right": 6.9849193096160889e-10, "nodeid": "666180.040000_1525894.770000" }, "geometry": { "type": "Point", "coordinates": [ 666180.040000000037253, 1525894.769999999320135 ] } }, +{ "type": "Feature", "properties": { "level_0": 664789.14617260336, "level_1": 1525073.3461271923, "branchtype": "river", "branchid": "branch_11", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_11", "frictionid": "Manning_0.023", "diameter": null, "index_right": 12, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "where": "upstream", "distance_right": 4.4079386833570057e-07, "nodeid": "664789.146173_1525073.346127" }, "geometry": { "type": "Point", "coordinates": [ 664789.146172603359446, 1525073.346127192256972 ] } }, +{ "type": "Feature", "properties": { "level_0": 664190.38579999981, "level_1": 1525924.0326000003, "branchtype": "pipe", "branchid": "pipe_5", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_5", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 16, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 3.2927225399135965e-10, "nodeid": "664190.385800_1525924.032600" }, "geometry": { "type": "Point", "coordinates": [ 664190.385799999814481, 1525924.032600000267848 ] } }, +{ "type": "Feature", "properties": { "level_0": 664048.32531966059, "level_1": 1525098.0711124309, "branchtype": "pipe", "branchid": "pipe_9", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 20, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 5.4853769327396927e-07, "nodeid": "664048.325320_1525098.071112" }, "geometry": { "type": "Point", "coordinates": [ 664048.325319660594687, 1525098.071112430887297 ] } }, +{ "type": "Feature", "properties": { "level_0": 664702.72692603013, "level_1": 1525750.0985501537, "branchtype": "pipe", "branchid": "pipe_10", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 21, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 1.5659834095829541e-07, "nodeid": "664702.726926_1525750.098550" }, "geometry": { "type": "Point", "coordinates": [ 664702.726926030125469, 1525750.098550153663382 ] } }, +{ "type": "Feature", "properties": { "level_0": 664747.43349663052, "level_1": 1525729.6497995616, "branchtype": "pipe", "branchid": "pipe_12", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 23, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 5.7336208882836857e-07, "nodeid": "664747.433497_1525729.649800" }, "geometry": { "type": "Point", "coordinates": [ 664747.433496630517766, 1525729.649799561593682 ] } }, +{ "type": "Feature", "properties": { "level_0": 665219.64311349345, "level_1": 1525514.959856804, "branchtype": "pipe", "branchid": "pipe_14", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_14", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 25, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 5.3099907323260637e-07, "nodeid": "665219.643113_1525514.959857" }, "geometry": { "type": "Point", "coordinates": [ 665219.643113493453711, 1525514.959856803994626 ] } }, +{ "type": "Feature", "properties": { "level_0": 664708.73862075247, "level_1": 1524483.1447981687, "branchtype": "pipe", "branchid": "pipe_15", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_15", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 26, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 2.9945179934390397e-07, "nodeid": "664708.738621_1524483.144798" }, "geometry": { "type": "Point", "coordinates": [ 664708.738620752468705, 1524483.144798168679699 ] } }, +{ "type": "Feature", "properties": { "level_0": 665277.57411764679, "level_1": 1525446.3931947846, "branchtype": "pipe", "branchid": "pipe_16", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_16", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 27, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 4.136866578190493e-07, "nodeid": "665277.574118_1525446.393195" }, "geometry": { "type": "Point", "coordinates": [ 665277.574117646785453, 1525446.393194784643129 ] } }, +{ "type": "Feature", "properties": { "level_0": 665292.61532070651, "level_1": 1525470.8495163794, "branchtype": "pipe", "branchid": "pipe_17", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_17", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 28, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 4.7975319107342047e-07, "nodeid": "665292.615321_1525470.849516" }, "geometry": { "type": "Point", "coordinates": [ 665292.615320706507191, 1525470.849516379414126 ] } } ] } diff --git a/examples/dflowfm_local/geoms/branches.geojson b/examples/dflowfm_local/geoms/branches.geojson index d401d93b..9c509b9c 100644 --- a/examples/dflowfm_local/geoms/branches.geojson +++ b/examples/dflowfm_local/geoms/branches.geojson @@ -2,33 +2,33 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -{ "type": "Feature", "properties": { "branchid": "pipe_4", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_4", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_0_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664438.813829420600086, 1525829.800284768920392 ], [ 664429.038999999989755, 1526107.098 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "pipe_5", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_5", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_1_generated", "manhole_dn": "manhole_0_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664190.385799999814481, 1525924.032600000267848 ], [ 664438.813829420600086, 1525829.800284768920392 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "pipe_6", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_2_generated", "manhole_dn": "manhole_0_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664217.490140905487351, 1525583.23970616585575 ], [ 664438.813829420600086, 1525829.800284768920392 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "pipe_7", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_3_generated", "manhole_dn": "manhole_2_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 663936.864700614358298, 1525261.152571672573686 ], [ 664217.490140905487351, 1525583.23970616585575 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "pipe_8", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_4_generated", "manhole_dn": "manhole_3_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 663871.550461587961763, 1525175.738024139311165 ], [ 663897.086400000494905, 1525212.559499999275431 ], [ 663936.864700614358298, 1525261.152571672573686 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "pipe_9", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_5_generated", "manhole_dn": "manhole_4_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664048.325319660594687, 1525098.071112430887297 ], [ 663871.550461587961763, 1525175.738024139311165 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "pipe_10", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_6_generated", "manhole_dn": "manhole_7_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664702.726926030125469, 1525750.098550153663382 ], [ 664481.894200000097044, 1525830.303300000727177 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "pipe_11", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_7_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664481.894200000097044, 1525830.303300000727177 ], [ 664474.13, 1526115.7 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "pipe_12", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_8_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664747.433496630517766, 1525729.649799561593682 ], [ 664838.810497992672026, 1525698.612855288665742 ], [ 664907.926478271954693, 1525663.288345249835402 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "pipe_13", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_13", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_9_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664849.475700000301003, 1525031.354499999433756 ], [ 665115.699999999953434, 1524944.79 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "pipe_14", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_14", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_10_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665219.643113493453711, 1525514.959856803994626 ], [ 665030.18360000057146, 1525603.506899999454618 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "pipe_15", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_15", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_11_generated", "manhole_dn": "manhole_9_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664708.738620752468705, 1524483.144798168679699 ], [ 664849.475700000301003, 1525031.354499999433756 ], [ 664849.475700000301003, 1525031.354499999433756 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "pipe_16", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_16", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_12_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665277.574117646785453, 1525446.393194784643129 ], [ 665356.868200000026263, 1525406.9835 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "pipe_17", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_17", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_13_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665292.615320706507191, 1525470.849516379414126 ], [ 665369.906399999978021, 1525431.4412 ], [ 665369.906399999978021, 1525431.4412 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "river_1", "branchtype": "river", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_1", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664057.966296999948099, 1526147.834882 ], [ 663918.391924358904362, 1525803.10090322420001 ], [ 663700.482064640615135, 1525466.331120023271069 ], [ 663353.045365229598247, 1525088.417517154943198 ], [ 662879.129516471526586, 1524643.454726681346074 ], [ 662793.794186791637912, 1524515.451732161454856 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "river_2", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_2", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664057.966296999948099, 1526147.834882 ], [ 664218.310854589915834, 1526625.788610660471022 ], [ 664218.310854589915834, 1527005.169120056321844 ], [ 664197.234159623389132, 1527152.705984821310267 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "branch_1", "branchtype": "river", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_1", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665115.699999999953434, 1524944.79 ], [ 665356.868200000026263, 1525406.9835 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "branch_2", "branchtype": "river", "branchorder": 2.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_2", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665356.868200000026263, 1525406.9835 ], [ 665369.906399999978021, 1525431.441199999069795 ], [ 665369.906399999978021, 1525431.4412 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "branch_3", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_3", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665369.906399999978021, 1525431.4412 ], [ 665641.789999999804422, 1525937.96000000089407 ], [ 665641.789999999804422, 1525937.96000000089407 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "branch_4", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_4", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665641.789999999804422, 1525937.96000000089407 ], [ 665560.620547444559634, 1525952.124135404126719 ], [ 665480.575254552299157, 1525953.687039414886385 ], [ 665416.820000000414439, 1525962.189999999245629 ], [ 665346.659376955241896, 1525982.895817694021389 ], [ 665271.309999999706633, 1526001.859999999403954 ], [ 665243.630000000470318, 1526003.289999998640269 ], [ 665243.630000000470318, 1526003.289999997941777 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "branch_5", "branchtype": "river", "branchorder": 3.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_5", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665243.630000000470318, 1526003.289999997941777 ], [ 665116.950000000419095, 1525983.029999999096617 ], [ 665051.90000000083819, 1525977.32 ], [ 664963.504724813159555, 1526014.666760261869058 ], [ 664918.370000000344589, 1526039.810000000521541 ], [ 664826.210000000428408, 1526041.519999999552965 ], [ 664752.459499345044605, 1526065.157490010838956 ], [ 664672.28994727297686, 1526086.417805780190974 ], [ 664642.852168873418123, 1526095.560649296734482 ], [ 664550.869999999529682, 1526115.410000000149012 ], [ 664474.13, 1526115.7 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "branch_6", "branchtype": "river", "branchorder": 4.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_6", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664474.13, 1526115.7 ], [ 664429.038999999989755, 1526107.098 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "branch_7", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_7", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664429.038999999989755, 1526107.098 ], [ 664272.40999999945052, 1526129.970000000204891 ], [ 664169.979999999864958, 1526140.529999999562278 ], [ 664092.240000000223517, 1526143.2899999988731 ], [ 664057.966296999948099, 1526147.834882 ], [ 664057.966296999948099, 1526147.834882 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "branch_8", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_8", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 666180.040000000037253, 1525894.769999999320135 ], [ 665891.336423385655507, 1526041.311705864733085 ], [ 665733.269999999320135, 1526117.310000000521541 ], [ 665733.269999999320135, 1526117.310000000521541 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "branch_10", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_10", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665733.269999999320135, 1526117.310000000521541 ], [ 665641.789999999804422, 1525937.96000000089407 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "branch_11", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_11", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664789.146172603359446, 1525073.346127192256972 ], [ 665015.157200000365265, 1525576.51439999951981 ], [ 665015.157200000365265, 1525576.514399999286979 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "branch_12", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_12", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665015.157200000365265, 1525576.514399999286979 ], [ 665030.18360000057146, 1525603.506899999454618 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "branch_13", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_13", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665030.18360000057146, 1525603.506899999454618 ], [ 665243.630000000470318, 1526003.289999997941777 ] ] } } +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_4", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_4", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_0_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664438.813829420600086, 1525829.800284768920392 ], [ 664429.038999999989755, 1526107.098 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_5", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_5", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_1_generated", "manhole_dn": "manhole_0_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664190.385799999814481, 1525924.032600000267848 ], [ 664438.813829420600086, 1525829.800284768920392 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_6", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_2_generated", "manhole_dn": "manhole_0_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664217.490140905487351, 1525583.23970616585575 ], [ 664438.813829420600086, 1525829.800284768920392 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_7", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_3_generated", "manhole_dn": "manhole_2_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 663936.864700614358298, 1525261.152571672573686 ], [ 664217.490140905487351, 1525583.23970616585575 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_8", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_4_generated", "manhole_dn": "manhole_3_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 663871.550461587961763, 1525175.738024139311165 ], [ 663897.086400000494905, 1525212.559499999275431 ], [ 663936.864700614358298, 1525261.152571672573686 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_9", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_5_generated", "manhole_dn": "manhole_4_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664048.325319660594687, 1525098.071112430887297 ], [ 663871.550461587961763, 1525175.738024139311165 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_10", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_6_generated", "manhole_dn": "manhole_7_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664702.726926030125469, 1525750.098550153663382 ], [ 664481.894200000097044, 1525830.303300000727177 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_11", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_7_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664481.894200000097044, 1525830.303300000727177 ], [ 664474.13, 1526115.7 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_12", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_8_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664747.433496630517766, 1525729.649799561593682 ], [ 664838.810497992672026, 1525698.612855288665742 ], [ 664907.926478271954693, 1525663.288345249835402 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_13", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_13", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_9_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664849.475700000301003, 1525031.354499999433756 ], [ 665115.699999999953434, 1524944.79 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_14", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_14", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_10_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665219.643113493453711, 1525514.959856803994626 ], [ 665030.18360000057146, 1525603.506899999454618 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_15", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_15", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_11_generated", "manhole_dn": "manhole_9_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664708.738620752468705, 1524483.144798168679699 ], [ 664849.475700000301003, 1525031.354499999433756 ], [ 664849.475700000301003, 1525031.354499999433756 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_16", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_16", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_12_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665277.574117646785453, 1525446.393194784643129 ], [ 665356.868200000026263, 1525406.9835 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_17", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_17", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_13_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665292.615320706507191, 1525470.849516379414126 ], [ 665369.906399999978021, 1525431.4412 ], [ 665369.906399999978021, 1525431.4412 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "river_1", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_1", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664057.966296999948099, 1526147.834882 ], [ 663918.391924358904362, 1525803.10090322420001 ], [ 663700.482064640615135, 1525466.331120023271069 ], [ 663353.045365229598247, 1525088.417517154943198 ], [ 662879.129516471526586, 1524643.454726681346074 ], [ 662793.794186791637912, 1524515.451732161454856 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "river_2", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_2", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664057.966296999948099, 1526147.834882 ], [ 664218.310854589915834, 1526625.788610660471022 ], [ 664218.310854589915834, 1527005.169120056321844 ], [ 664197.234159623389132, 1527152.705984821310267 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_1", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_1", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665115.699999999953434, 1524944.79 ], [ 665356.868200000026263, 1525406.9835 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_2", "branchorder": 2.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_2", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665356.868200000026263, 1525406.9835 ], [ 665369.906399999978021, 1525431.441199999069795 ], [ 665369.906399999978021, 1525431.4412 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_3", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_3", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665369.906399999978021, 1525431.4412 ], [ 665641.789999999804422, 1525937.96000000089407 ], [ 665641.789999999804422, 1525937.96000000089407 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_4", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_4", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665641.789999999804422, 1525937.96000000089407 ], [ 665560.620547444559634, 1525952.124135404126719 ], [ 665480.575254552299157, 1525953.687039414886385 ], [ 665416.820000000414439, 1525962.189999999245629 ], [ 665346.659376955241896, 1525982.895817694021389 ], [ 665271.309999999706633, 1526001.859999999403954 ], [ 665243.630000000470318, 1526003.289999998640269 ], [ 665243.630000000470318, 1526003.289999997941777 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_5", "branchorder": 3.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_5", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665243.630000000470318, 1526003.289999997941777 ], [ 665116.950000000419095, 1525983.029999999096617 ], [ 665051.90000000083819, 1525977.32 ], [ 664963.504724813159555, 1526014.666760261869058 ], [ 664918.370000000344589, 1526039.810000000521541 ], [ 664826.210000000428408, 1526041.519999999552965 ], [ 664752.459499345044605, 1526065.157490010838956 ], [ 664672.28994727297686, 1526086.417805780190974 ], [ 664642.852168873418123, 1526095.560649296734482 ], [ 664550.869999999529682, 1526115.410000000149012 ], [ 664474.13, 1526115.7 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_6", "branchorder": 4.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_6", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664474.13, 1526115.7 ], [ 664429.038999999989755, 1526107.098 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_7", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_7", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664429.038999999989755, 1526107.098 ], [ 664272.40999999945052, 1526129.970000000204891 ], [ 664169.979999999864958, 1526140.529999999562278 ], [ 664092.240000000223517, 1526143.2899999988731 ], [ 664057.966296999948099, 1526147.834882 ], [ 664057.966296999948099, 1526147.834882 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_8", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_8", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 666180.040000000037253, 1525894.769999999320135 ], [ 665891.336423385655507, 1526041.311705864733085 ], [ 665733.269999999320135, 1526117.310000000521541 ], [ 665733.269999999320135, 1526117.310000000521541 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_10", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_10", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665733.269999999320135, 1526117.310000000521541 ], [ 665641.789999999804422, 1525937.96000000089407 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_11", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_11", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664789.146172603359446, 1525073.346127192256972 ], [ 665015.157200000365265, 1525576.51439999951981 ], [ 665015.157200000365265, 1525576.514399999286979 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_12", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_12", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665015.157200000365265, 1525576.514399999286979 ], [ 665030.18360000057146, 1525603.506899999454618 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_13", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_13", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665030.18360000057146, 1525603.506899999454618 ], [ 665243.630000000470318, 1526003.289999997941777 ] ] } } ] } diff --git a/examples/dflowfm_local/geoms/bridges.geojson b/examples/dflowfm_local/geoms/bridges.geojson index 490c5cce..2ed8bfd8 100644 --- a/examples/dflowfm_local/geoms/bridges.geojson +++ b/examples/dflowfm_local/geoms/bridges.geojson @@ -2,7 +2,7 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -{ "type": "Feature", "properties": { "branchid": "branch_12", "csdefid": "rect_h1.550_w2.000_cno_point", "friction": 0.023, "id": "bridge_1", "allowedflowdir": "positive", "outletlosscoeff": 0.2, "type": "bridge", "inletlosscoeff": 0.2, "chainage": 14.101, "length": 10.0, "shift": 2.34, "formfactor": null, "frictiontype": "Manning", "pillarwidth": null }, "geometry": { "type": "Point", "coordinates": [ 665021.849053248995915, 1525588.928306785644963 ] } }, -{ "type": "Feature", "properties": { "branchid": "branch_3", "csdefid": "rect_h1.800_w5.000_cyes_point", "friction": 0.023, "id": "bridge_2", "allowedflowdir": "both", "outletlosscoeff": 0.82, "type": "bridge", "inletlosscoeff": 0.8, "chainage": 485.794, "length": 5.0, "shift": 2.37, "formfactor": null, "frictiontype": "Manning", "pillarwidth": null }, "geometry": { "type": "Point", "coordinates": [ 665599.689329552114941, 1525859.454655284294859 ] } } +{ "type": "Feature", "properties": { "outletlosscoeff": 0.2, "inletlosscoeff": 0.2, "pillarwidth": null, "csdefid": "rect_h1.550_w2.000_cno_point", "shift": 2.34, "id": "bridge_1", "frictiontype": "Manning", "formfactor": null, "type": "bridge", "friction": 0.023, "allowedflowdir": "positive", "chainage": 14.101, "branchid": "branch_12", "length": 10.0 }, "geometry": { "type": "Point", "coordinates": [ 665021.849053248995915, 1525588.928306785644963 ] } }, +{ "type": "Feature", "properties": { "outletlosscoeff": 0.82, "inletlosscoeff": 0.8, "pillarwidth": null, "csdefid": "rect_h1.800_w5.000_cyes_point", "shift": 2.37, "id": "bridge_2", "frictiontype": "Manning", "formfactor": null, "type": "bridge", "friction": 0.023, "allowedflowdir": "both", "chainage": 485.794, "branchid": "branch_3", "length": 5.0 }, "geometry": { "type": "Point", "coordinates": [ 665599.689329552114941, 1525859.454655284294859 ] } } ] } diff --git a/examples/dflowfm_local/geoms/culverts.geojson b/examples/dflowfm_local/geoms/culverts.geojson index 3ba6c28a..50c07170 100644 --- a/examples/dflowfm_local/geoms/culverts.geojson +++ b/examples/dflowfm_local/geoms/culverts.geojson @@ -2,6 +2,6 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -{ "type": "Feature", "properties": { "bedfriction": 0.012, "id": "culvert_1", "outletlosscoeff": 0.2, "type": "culvert", "valveopeningheight": null, "losscoeff": null, "length": 1.0, "numlosscoeff": null, "valveonoff": 0.0, "branchid": "branch_13", "leftlevel": 2.56, "csdefid": "rect_h1.500_w1.500_cyes_point", "allowedflowdir": "positive", "relopening": null, "inletlosscoeff": 0.2, "chainage": 331.832, "bedfrictiontype": "Manning", "rightlevel": 2.5 }, "geometry": { "type": "Point", "coordinates": [ 665186.754018069244921, 1525896.07843215460889 ] } } +{ "type": "Feature", "properties": { "rightlevel": 2.5, "leftlevel": 2.56, "bedfrictiontype": "Manning", "bedfriction": 0.012, "csdefid": "rect_h1.500_w1.500_cyes_point", "id": "culvert_1", "numlosscoeff": null, "type": "culvert", "allowedflowdir": "positive", "chainage": 331.832, "valveopeningheight": null, "branchid": "branch_13", "length": 1.0, "outletlosscoeff": 0.2, "inletlosscoeff": 0.2, "valveonoff": 0.0, "losscoeff": null, "relopening": null }, "geometry": { "type": "Point", "coordinates": [ 665186.754018069244921, 1525896.07843215460889 ] } } ] } diff --git a/examples/dflowfm_local/geoms/manholes.geojson b/examples/dflowfm_local/geoms/manholes.geojson index 1a835e0b..7a683068 100644 --- a/examples/dflowfm_local/geoms/manholes.geojson +++ b/examples/dflowfm_local/geoms/manholes.geojson @@ -2,19 +2,19 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -{ "type": "Feature", "properties": { "_index": 14, "bedlevel": -3.0, "branchid": "pipe_4;pipe_5;pipe_6", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_2", "shape": null, "area": 1.0, "streetlevel": 8.03125, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 4.7985182629097901e-07, "index_right": 15, "_streetlevel_dem": 8.03125, "nodeid": "664438.813829_1525829.800285", "id": "664438.813829_1525829.800285", "name": "MH_2", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664438.813829420600086, 1525829.800284768920392 ] } }, -{ "type": "Feature", "properties": { "_index": 15, "bedlevel": -3.0, "branchid": "pipe_5", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_1", "shape": null, "area": 1.0, "streetlevel": 4.9921875, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 3.2927225399135965e-10, "index_right": 16, "_streetlevel_dem": 4.9921875, "nodeid": "664190.385800_1525924.032600", "id": "664190.385800_1525924.032600", "name": "MH_1", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664190.385799999814481, 1525924.032600000267848 ] } }, -{ "type": "Feature", "properties": { "_index": 16, "bedlevel": -3.0, "branchid": "pipe_6;pipe_7", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_4", "shape": null, "area": 1.0, "streetlevel": 6.5546875, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 1.9083308615545579e-07, "index_right": 17, "_streetlevel_dem": 6.5546875, "nodeid": "664217.490141_1525583.239706", "id": "664217.490141_1525583.239706", "name": "MH_4", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664217.490140905487351, 1525583.23970616585575 ] } }, -{ "type": "Feature", "properties": { "_index": 17, "bedlevel": -3.0, "branchid": "pipe_7;pipe_8", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_5", "shape": null, "area": 1.0, "streetlevel": 5.7421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 5.0588201413871898e-07, "index_right": 18, "_streetlevel_dem": 5.7421875, "nodeid": "663936.864701_1525261.152572", "id": "663936.864701_1525261.152572", "name": "MH_5", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 663936.864700614358298, 1525261.152571672573686 ] } }, -{ "type": "Feature", "properties": { "_index": 18, "bedlevel": -3.0, "branchid": "pipe_8;pipe_9", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_6", "shape": null, "area": 1.0, "streetlevel": 7.640625, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 4.348846544242845e-07, "index_right": 19, "_streetlevel_dem": 7.640625, "nodeid": "663871.550462_1525175.738024", "id": "663871.550462_1525175.738024", "name": "MH_6", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 663871.550461587961763, 1525175.738024139311165 ] } }, -{ "type": "Feature", "properties": { "_index": 19, "bedlevel": -3.0, "branchid": "pipe_9", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_7", "shape": null, "area": 1.0, "streetlevel": 6.2421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 5.4853769327396927e-07, "index_right": 20, "_streetlevel_dem": 6.2421875, "nodeid": "664048.325320_1525098.071112", "id": "664048.325320_1525098.071112", "name": "MH_7", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664048.325319660594687, 1525098.071112430887297 ] } }, -{ "type": "Feature", "properties": { "_index": 20, "bedlevel": -3.0, "branchid": "pipe_10", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_9", "shape": null, "area": 1.0, "streetlevel": 6.78125, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 1.5659834095829541e-07, "index_right": 21, "_streetlevel_dem": 6.78125, "nodeid": "664702.726926_1525750.098550", "id": "664702.726926_1525750.098550", "name": "MH_9", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664702.726926030125469, 1525750.098550153663382 ] } }, -{ "type": "Feature", "properties": { "_index": 20, "bedlevel": -3.0, "branchid": "pipe_10;pipe_11", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_8", "shape": null, "area": 1.0, "streetlevel": 7.8125, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 7.0812675756148753e-10, "index_right": 22, "_streetlevel_dem": 7.8125, "nodeid": "664481.894200_1525830.303300", "id": "664481.894200_1525830.303300", "name": "MH_8", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664481.894200000097044, 1525830.303300000727177 ] } }, -{ "type": "Feature", "properties": { "_index": 22, "bedlevel": -3.0, "branchid": "pipe_12", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_10", "shape": null, "area": 1.0, "streetlevel": 6.6328125, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 5.7336208882836857e-07, "index_right": 23, "_streetlevel_dem": 6.6328125, "nodeid": "664747.433497_1525729.649800", "id": "664747.433497_1525729.649800", "name": "MH_10", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664747.433496630517766, 1525729.649799561593682 ] } }, -{ "type": "Feature", "properties": { "_index": 23, "bedlevel": -3.0, "branchid": "pipe_13;pipe_15", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_15", "shape": null, "area": 1.0, "streetlevel": 7.3203125, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 5.8207660913467407e-10, "index_right": 24, "_streetlevel_dem": 7.3203125, "nodeid": "664849.475700_1525031.354500", "id": "664849.475700_1525031.354500", "name": "MH_15", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664849.475700000301003, 1525031.354499999433756 ] } }, -{ "type": "Feature", "properties": { "_index": 24, "bedlevel": -3.0, "branchid": "pipe_14", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_11", "shape": null, "area": 1.0, "streetlevel": 6.5625, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 5.3099907323260637e-07, "index_right": 25, "_streetlevel_dem": 6.5625, "nodeid": "665219.643113_1525514.959857", "id": "665219.643113_1525514.959857", "name": "MH_11", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 665219.643113493453711, 1525514.959856803994626 ] } }, -{ "type": "Feature", "properties": { "_index": 25, "bedlevel": -3.0, "branchid": "pipe_15", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_14", "shape": null, "area": 1.0, "streetlevel": 5.9453125, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 2.9945179934390397e-07, "index_right": 26, "_streetlevel_dem": 5.9453125, "nodeid": "664708.738621_1524483.144798", "id": "664708.738621_1524483.144798", "name": "MH_14", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664708.738620752468705, 1524483.144798168679699 ] } }, -{ "type": "Feature", "properties": { "_index": 26, "bedlevel": -3.0, "branchid": "pipe_16", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_13", "shape": null, "area": 1.0, "streetlevel": 6.34375, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 4.136866578190493e-07, "index_right": 27, "_streetlevel_dem": 6.34375, "nodeid": "665277.574118_1525446.393195", "id": "665277.574118_1525446.393195", "name": "MH_13", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 665277.574117646785453, 1525446.393194784643129 ] } }, -{ "type": "Feature", "properties": { "_index": 27, "bedlevel": -3.0, "branchid": "pipe_17", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_12", "shape": null, "area": 1.0, "streetlevel": 6.34375, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 4.7975319107342047e-07, "index_right": 28, "_streetlevel_dem": 6.34375, "nodeid": "665292.615321_1525470.849516", "id": "665292.615321_1525470.849516", "name": "MH_12", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 665292.615320706507191, 1525470.849516379414126 ] } } +{ "type": "Feature", "properties": { "_index": 14, "bedlevel": -3.0, "branchid": "pipe_4;pipe_5;pipe_6", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_2", "shape": null, "area": 1.0, "streetlevel": 8.03125, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 4.7985182629097901e-07, "index_right": 15, "_streetlevel_dem": 8.03125, "nodeid": "664438.813829_1525829.800285", "id": "664438.813829_1525829.800285", "name": "MH_2", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664438.813829420600086, 1525829.800284768920392 ] } }, +{ "type": "Feature", "properties": { "_index": 15, "bedlevel": -3.0, "branchid": "pipe_5", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_1", "shape": null, "area": 1.0, "streetlevel": 4.9921875, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 3.2927225399135965e-10, "index_right": 16, "_streetlevel_dem": 4.9921875, "nodeid": "664190.385800_1525924.032600", "id": "664190.385800_1525924.032600", "name": "MH_1", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664190.385799999814481, 1525924.032600000267848 ] } }, +{ "type": "Feature", "properties": { "_index": 16, "bedlevel": -3.0, "branchid": "pipe_6;pipe_7", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_4", "shape": null, "area": 1.0, "streetlevel": 6.5546875, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 1.9083308615545579e-07, "index_right": 17, "_streetlevel_dem": 6.5546875, "nodeid": "664217.490141_1525583.239706", "id": "664217.490141_1525583.239706", "name": "MH_4", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664217.490140905487351, 1525583.23970616585575 ] } }, +{ "type": "Feature", "properties": { "_index": 17, "bedlevel": -3.0, "branchid": "pipe_7;pipe_8", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_5", "shape": null, "area": 1.0, "streetlevel": 5.7421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 5.0588201413871898e-07, "index_right": 18, "_streetlevel_dem": 5.7421875, "nodeid": "663936.864701_1525261.152572", "id": "663936.864701_1525261.152572", "name": "MH_5", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 663936.864700614358298, 1525261.152571672573686 ] } }, +{ "type": "Feature", "properties": { "_index": 18, "bedlevel": -3.0, "branchid": "pipe_8;pipe_9", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_6", "shape": null, "area": 1.0, "streetlevel": 7.640625, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 4.348846544242845e-07, "index_right": 19, "_streetlevel_dem": 7.640625, "nodeid": "663871.550462_1525175.738024", "id": "663871.550462_1525175.738024", "name": "MH_6", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 663871.550461587961763, 1525175.738024139311165 ] } }, +{ "type": "Feature", "properties": { "_index": 19, "bedlevel": -3.0, "branchid": "pipe_9", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_7", "shape": null, "area": 1.0, "streetlevel": 6.2421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 5.4853769327396927e-07, "index_right": 20, "_streetlevel_dem": 6.2421875, "nodeid": "664048.325320_1525098.071112", "id": "664048.325320_1525098.071112", "name": "MH_7", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664048.325319660594687, 1525098.071112430887297 ] } }, +{ "type": "Feature", "properties": { "_index": 20, "bedlevel": -3.0, "branchid": "pipe_10", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_9", "shape": null, "area": 1.0, "streetlevel": 6.78125, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 1.5659834095829541e-07, "index_right": 21, "_streetlevel_dem": 6.78125, "nodeid": "664702.726926_1525750.098550", "id": "664702.726926_1525750.098550", "name": "MH_9", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664702.726926030125469, 1525750.098550153663382 ] } }, +{ "type": "Feature", "properties": { "_index": 20, "bedlevel": -3.0, "branchid": "pipe_10;pipe_11", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_8", "shape": null, "area": 1.0, "streetlevel": 7.8125, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 7.0812675756148753e-10, "index_right": 22, "_streetlevel_dem": 7.8125, "nodeid": "664481.894200_1525830.303300", "id": "664481.894200_1525830.303300", "name": "MH_8", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664481.894200000097044, 1525830.303300000727177 ] } }, +{ "type": "Feature", "properties": { "_index": 22, "bedlevel": -3.0, "branchid": "pipe_12", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_10", "shape": null, "area": 1.0, "streetlevel": 6.6328125, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 5.7336208882836857e-07, "index_right": 23, "_streetlevel_dem": 6.6328125, "nodeid": "664747.433497_1525729.649800", "id": "664747.433497_1525729.649800", "name": "MH_10", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664747.433496630517766, 1525729.649799561593682 ] } }, +{ "type": "Feature", "properties": { "_index": 23, "bedlevel": -3.0, "branchid": "pipe_13;pipe_15", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_15", "shape": null, "area": 1.0, "streetlevel": 7.3203125, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 5.8207660913467407e-10, "index_right": 24, "_streetlevel_dem": 7.3203125, "nodeid": "664849.475700_1525031.354500", "id": "664849.475700_1525031.354500", "name": "MH_15", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664849.475700000301003, 1525031.354499999433756 ] } }, +{ "type": "Feature", "properties": { "_index": 24, "bedlevel": -3.0, "branchid": "pipe_14", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_11", "shape": null, "area": 1.0, "streetlevel": 6.5625, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 5.3099907323260637e-07, "index_right": 25, "_streetlevel_dem": 6.5625, "nodeid": "665219.643113_1525514.959857", "id": "665219.643113_1525514.959857", "name": "MH_11", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 665219.643113493453711, 1525514.959856803994626 ] } }, +{ "type": "Feature", "properties": { "_index": 25, "bedlevel": -3.0, "branchid": "pipe_15", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_14", "shape": null, "area": 1.0, "streetlevel": 5.9453125, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 2.9945179934390397e-07, "index_right": 26, "_streetlevel_dem": 5.9453125, "nodeid": "664708.738621_1524483.144798", "id": "664708.738621_1524483.144798", "name": "MH_14", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664708.738620752468705, 1524483.144798168679699 ] } }, +{ "type": "Feature", "properties": { "_index": 26, "bedlevel": -3.0, "branchid": "pipe_16", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_13", "shape": null, "area": 1.0, "streetlevel": 6.34375, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 4.136866578190493e-07, "index_right": 27, "_streetlevel_dem": 6.34375, "nodeid": "665277.574118_1525446.393195", "id": "665277.574118_1525446.393195", "name": "MH_13", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 665277.574117646785453, 1525446.393194784643129 ] } }, +{ "type": "Feature", "properties": { "_index": 27, "bedlevel": -3.0, "branchid": "pipe_17", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_12", "shape": null, "area": 1.0, "streetlevel": 6.34375, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 4.7975319107342047e-07, "index_right": 28, "_streetlevel_dem": 6.34375, "nodeid": "665292.615321_1525470.849516", "id": "665292.615321_1525470.849516", "name": "MH_12", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 665292.615320706507191, 1525470.849516379414126 ] } } ] } diff --git a/examples/dflowfm_local/geoms/pipe_nodes.geojson b/examples/dflowfm_local/geoms/pipe_nodes.geojson index f7f42f93..90a5c1bb 100644 --- a/examples/dflowfm_local/geoms/pipe_nodes.geojson +++ b/examples/dflowfm_local/geoms/pipe_nodes.geojson @@ -2,25 +2,25 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_0", "branch_id": "pipe_4", "branchid": "pipe_4", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_4" }, "geometry": { "type": "Point", "coordinates": [ 664438.813829420600086, 1525829.800284768920392 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_1", "branch_id": "pipe_4", "branchid": "pipe_4", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_4" }, "geometry": { "type": "Point", "coordinates": [ 664429.038999999407679, 1526107.097999999299645 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_2", "branch_id": "pipe_5", "branchid": "pipe_5", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_5" }, "geometry": { "type": "Point", "coordinates": [ 664190.385799999814481, 1525924.032600000267848 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_3", "branch_id": "pipe_6", "branchid": "pipe_6", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_6" }, "geometry": { "type": "Point", "coordinates": [ 664217.490140905487351, 1525583.23970616585575 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_4", "branch_id": "pipe_7", "branchid": "pipe_7", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_7" }, "geometry": { "type": "Point", "coordinates": [ 663936.864700614358298, 1525261.152571672573686 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_5", "branch_id": "pipe_8", "branchid": "pipe_8", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_8" }, "geometry": { "type": "Point", "coordinates": [ 663871.550461587961763, 1525175.738024139311165 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_6", "branch_id": "pipe_9", "branchid": "pipe_9", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_9" }, "geometry": { "type": "Point", "coordinates": [ 664048.325319660594687, 1525098.071112430887297 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_7", "branch_id": "pipe_10", "branchid": "pipe_10", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_10" }, "geometry": { "type": "Point", "coordinates": [ 664702.726926030125469, 1525750.098550153663382 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_8", "branch_id": "pipe_10", "branchid": "pipe_10", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_10" }, "geometry": { "type": "Point", "coordinates": [ 664481.894200000097044, 1525830.303300000727177 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_9", "branch_id": "pipe_11", "branchid": "pipe_11", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_11" }, "geometry": { "type": "Point", "coordinates": [ 664474.13, 1526115.699999999254942 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_10", "branch_id": "pipe_12", "branchid": "pipe_12", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_12" }, "geometry": { "type": "Point", "coordinates": [ 664747.433496630517766, 1525729.649799561593682 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_11", "branch_id": "pipe_12", "branchid": "pipe_12", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_12" }, "geometry": { "type": "Point", "coordinates": [ 665030.18360000057146, 1525603.506899999454618 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_12", "branch_id": "pipe_13", "branchid": "pipe_13", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_13" }, "geometry": { "type": "Point", "coordinates": [ 664849.475700000301003, 1525031.354499999433756 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_13", "branch_id": "pipe_13", "branchid": "pipe_13", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_13" }, "geometry": { "type": "Point", "coordinates": [ 665115.70000000030268, 1524944.7899999988731 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_14", "branch_id": "pipe_14", "branchid": "pipe_14", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_14" }, "geometry": { "type": "Point", "coordinates": [ 665219.643113493453711, 1525514.959856803994626 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_15", "branch_id": "pipe_15", "branchid": "pipe_15", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_15" }, "geometry": { "type": "Point", "coordinates": [ 664708.738620752468705, 1524483.144798168679699 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_16", "branch_id": "pipe_16", "branchid": "pipe_16", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_16" }, "geometry": { "type": "Point", "coordinates": [ 665277.574117646785453, 1525446.393194784643129 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_17", "branch_id": "pipe_16", "branchid": "pipe_16", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_16" }, "geometry": { "type": "Point", "coordinates": [ 665356.868200001074001, 1525406.983500000322238 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_18", "branch_id": "pipe_17", "branchid": "pipe_17", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_17" }, "geometry": { "type": "Point", "coordinates": [ 665292.615320706507191, 1525470.849516379414126 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_19", "branch_id": "pipe_17", "branchid": "pipe_17", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_17" }, "geometry": { "type": "Point", "coordinates": [ 665369.906399999978021, 1525431.441199998836964 ] } } +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_0", "branch_id": "pipe_4", "branchtype": "pipe", "branchid": "pipe_4", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_4" }, "geometry": { "type": "Point", "coordinates": [ 664438.813829420600086, 1525829.800284768920392 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_1", "branch_id": "pipe_4", "branchtype": "pipe", "branchid": "pipe_4", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_4" }, "geometry": { "type": "Point", "coordinates": [ 664429.038999999407679, 1526107.097999999299645 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_2", "branch_id": "pipe_5", "branchtype": "pipe", "branchid": "pipe_5", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_5" }, "geometry": { "type": "Point", "coordinates": [ 664190.385799999814481, 1525924.032600000267848 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_3", "branch_id": "pipe_6", "branchtype": "pipe", "branchid": "pipe_6", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_6" }, "geometry": { "type": "Point", "coordinates": [ 664217.490140905487351, 1525583.23970616585575 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_4", "branch_id": "pipe_7", "branchtype": "pipe", "branchid": "pipe_7", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_7" }, "geometry": { "type": "Point", "coordinates": [ 663936.864700614358298, 1525261.152571672573686 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_5", "branch_id": "pipe_8", "branchtype": "pipe", "branchid": "pipe_8", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_8" }, "geometry": { "type": "Point", "coordinates": [ 663871.550461587961763, 1525175.738024139311165 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_6", "branch_id": "pipe_9", "branchtype": "pipe", "branchid": "pipe_9", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_9" }, "geometry": { "type": "Point", "coordinates": [ 664048.325319660594687, 1525098.071112430887297 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_7", "branch_id": "pipe_10", "branchtype": "pipe", "branchid": "pipe_10", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_10" }, "geometry": { "type": "Point", "coordinates": [ 664702.726926030125469, 1525750.098550153663382 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_8", "branch_id": "pipe_10", "branchtype": "pipe", "branchid": "pipe_10", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_10" }, "geometry": { "type": "Point", "coordinates": [ 664481.894200000097044, 1525830.303300000727177 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_9", "branch_id": "pipe_11", "branchtype": "pipe", "branchid": "pipe_11", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_11" }, "geometry": { "type": "Point", "coordinates": [ 664474.13, 1526115.699999999254942 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_10", "branch_id": "pipe_12", "branchtype": "pipe", "branchid": "pipe_12", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_12" }, "geometry": { "type": "Point", "coordinates": [ 664747.433496630517766, 1525729.649799561593682 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_11", "branch_id": "pipe_12", "branchtype": "pipe", "branchid": "pipe_12", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_12" }, "geometry": { "type": "Point", "coordinates": [ 665030.18360000057146, 1525603.506899999454618 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_12", "branch_id": "pipe_13", "branchtype": "pipe", "branchid": "pipe_13", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_13" }, "geometry": { "type": "Point", "coordinates": [ 664849.475700000301003, 1525031.354499999433756 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_13", "branch_id": "pipe_13", "branchtype": "pipe", "branchid": "pipe_13", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_13" }, "geometry": { "type": "Point", "coordinates": [ 665115.70000000030268, 1524944.7899999988731 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_14", "branch_id": "pipe_14", "branchtype": "pipe", "branchid": "pipe_14", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_14" }, "geometry": { "type": "Point", "coordinates": [ 665219.643113493453711, 1525514.959856803994626 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_15", "branch_id": "pipe_15", "branchtype": "pipe", "branchid": "pipe_15", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_15" }, "geometry": { "type": "Point", "coordinates": [ 664708.738620752468705, 1524483.144798168679699 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_16", "branch_id": "pipe_16", "branchtype": "pipe", "branchid": "pipe_16", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_16" }, "geometry": { "type": "Point", "coordinates": [ 665277.574117646785453, 1525446.393194784643129 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_17", "branch_id": "pipe_16", "branchtype": "pipe", "branchid": "pipe_16", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_16" }, "geometry": { "type": "Point", "coordinates": [ 665356.868200001074001, 1525406.983500000322238 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_18", "branch_id": "pipe_17", "branchtype": "pipe", "branchid": "pipe_17", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_17" }, "geometry": { "type": "Point", "coordinates": [ 665292.615320706507191, 1525470.849516379414126 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_19", "branch_id": "pipe_17", "branchtype": "pipe", "branchid": "pipe_17", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_17" }, "geometry": { "type": "Point", "coordinates": [ 665369.906399999978021, 1525431.441199998836964 ] } } ] } diff --git a/examples/dflowfm_local/geoms/pipes.geojson b/examples/dflowfm_local/geoms/pipes.geojson index 0c634f01..e604ea79 100644 --- a/examples/dflowfm_local/geoms/pipes.geojson +++ b/examples/dflowfm_local/geoms/pipes.geojson @@ -2,19 +2,19 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -{ "type": "Feature", "properties": { "branchid": "pipe_4", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_4", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_0_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664438.813829420600086, 1525829.800284768920392 ], [ 664429.038999999989755, 1526107.098 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "pipe_5", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_5", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_1_generated", "manhole_dn": "manhole_0_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664190.385799999814481, 1525924.032600000267848 ], [ 664438.813829420600086, 1525829.800284768920392 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "pipe_6", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_2_generated", "manhole_dn": "manhole_0_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664217.490140905487351, 1525583.23970616585575 ], [ 664438.813829420600086, 1525829.800284768920392 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "pipe_7", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_3_generated", "manhole_dn": "manhole_2_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 663936.864700614358298, 1525261.152571672573686 ], [ 664217.490140905487351, 1525583.23970616585575 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "pipe_8", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_4_generated", "manhole_dn": "manhole_3_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 663871.550461587961763, 1525175.738024139311165 ], [ 663897.086400000494905, 1525212.559499999275431 ], [ 663936.864700614358298, 1525261.152571672573686 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "pipe_9", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_5_generated", "manhole_dn": "manhole_4_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664048.325319660594687, 1525098.071112430887297 ], [ 663871.550461587961763, 1525175.738024139311165 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "pipe_10", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_6_generated", "manhole_dn": "manhole_7_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664702.726926030125469, 1525750.098550153663382 ], [ 664481.894200000097044, 1525830.303300000727177 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "pipe_11", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_7_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664481.894200000097044, 1525830.303300000727177 ], [ 664474.13, 1526115.7 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "pipe_12", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_8_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664747.433496630517766, 1525729.649799561593682 ], [ 664838.810497992672026, 1525698.612855288665742 ], [ 664907.926478271954693, 1525663.288345249835402 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "pipe_13", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_13", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_9_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664849.475700000301003, 1525031.354499999433756 ], [ 665115.699999999953434, 1524944.79 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "pipe_14", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_14", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_10_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665219.643113493453711, 1525514.959856803994626 ], [ 665030.18360000057146, 1525603.506899999454618 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "pipe_15", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_15", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_11_generated", "manhole_dn": "manhole_9_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664708.738620752468705, 1524483.144798168679699 ], [ 664849.475700000301003, 1525031.354499999433756 ], [ 664849.475700000301003, 1525031.354499999433756 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "pipe_16", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_16", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_12_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665277.574117646785453, 1525446.393194784643129 ], [ 665356.868200000026263, 1525406.9835 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "pipe_17", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_17", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_13_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665292.615320706507191, 1525470.849516379414126 ], [ 665369.906399999978021, 1525431.4412 ], [ 665369.906399999978021, 1525431.4412 ] ] } } +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_4", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_4", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_0_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664438.813829420600086, 1525829.800284768920392 ], [ 664429.038999999989755, 1526107.098 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_5", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_5", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_1_generated", "manhole_dn": "manhole_0_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664190.385799999814481, 1525924.032600000267848 ], [ 664438.813829420600086, 1525829.800284768920392 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_6", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_2_generated", "manhole_dn": "manhole_0_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664217.490140905487351, 1525583.23970616585575 ], [ 664438.813829420600086, 1525829.800284768920392 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_7", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_3_generated", "manhole_dn": "manhole_2_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 663936.864700614358298, 1525261.152571672573686 ], [ 664217.490140905487351, 1525583.23970616585575 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_8", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_4_generated", "manhole_dn": "manhole_3_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 663871.550461587961763, 1525175.738024139311165 ], [ 663897.086400000494905, 1525212.559499999275431 ], [ 663936.864700614358298, 1525261.152571672573686 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_9", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_5_generated", "manhole_dn": "manhole_4_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664048.325319660594687, 1525098.071112430887297 ], [ 663871.550461587961763, 1525175.738024139311165 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_10", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_6_generated", "manhole_dn": "manhole_7_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664702.726926030125469, 1525750.098550153663382 ], [ 664481.894200000097044, 1525830.303300000727177 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_11", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_7_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664481.894200000097044, 1525830.303300000727177 ], [ 664474.13, 1526115.7 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_12", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_8_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664747.433496630517766, 1525729.649799561593682 ], [ 664838.810497992672026, 1525698.612855288665742 ], [ 664907.926478271954693, 1525663.288345249835402 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_13", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_13", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_9_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664849.475700000301003, 1525031.354499999433756 ], [ 665115.699999999953434, 1524944.79 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_14", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_14", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_10_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665219.643113493453711, 1525514.959856803994626 ], [ 665030.18360000057146, 1525603.506899999454618 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_15", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_15", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_11_generated", "manhole_dn": "manhole_9_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664708.738620752468705, 1524483.144798168679699 ], [ 664849.475700000301003, 1525031.354499999433756 ], [ 664849.475700000301003, 1525031.354499999433756 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_16", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_16", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_12_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665277.574117646785453, 1525446.393194784643129 ], [ 665356.868200000026263, 1525406.9835 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_17", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_17", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_13_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665292.615320706507191, 1525470.849516379414126 ], [ 665369.906399999978021, 1525431.4412 ], [ 665369.906399999978021, 1525431.4412 ] ] } } ] } diff --git a/examples/dflowfm_local/geoms/rivers.geojson b/examples/dflowfm_local/geoms/rivers.geojson index 0216bc58..419ed91c 100644 --- a/examples/dflowfm_local/geoms/rivers.geojson +++ b/examples/dflowfm_local/geoms/rivers.geojson @@ -2,19 +2,19 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -{ "type": "Feature", "properties": { "branchid": "river_1", "branchtype": "river", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_1", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664057.966296999948099, 1526147.834882 ], [ 663918.391924358904362, 1525803.10090322420001 ], [ 663700.482064640615135, 1525466.331120023271069 ], [ 663353.045365229598247, 1525088.417517154943198 ], [ 662879.129516471526586, 1524643.454726681346074 ], [ 662793.794186791637912, 1524515.451732161454856 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "river_2", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_2", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664057.966296999948099, 1526147.834882 ], [ 664218.310854589915834, 1526625.788610660471022 ], [ 664218.310854589915834, 1527005.169120056321844 ], [ 664197.234159623389132, 1527152.705984821310267 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "branch_1", "branchtype": "river", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_1", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665115.699999999953434, 1524944.79 ], [ 665356.868200000026263, 1525406.9835 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "branch_2", "branchtype": "river", "branchorder": 2.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_2", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665356.868200000026263, 1525406.9835 ], [ 665369.906399999978021, 1525431.441199999069795 ], [ 665369.906399999978021, 1525431.4412 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "branch_3", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_3", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665369.906399999978021, 1525431.4412 ], [ 665641.789999999804422, 1525937.96000000089407 ], [ 665641.789999999804422, 1525937.96000000089407 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "branch_4", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_4", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665641.789999999804422, 1525937.96000000089407 ], [ 665560.620547444559634, 1525952.124135404126719 ], [ 665480.575254552299157, 1525953.687039414886385 ], [ 665416.820000000414439, 1525962.189999999245629 ], [ 665346.659376955241896, 1525982.895817694021389 ], [ 665271.309999999706633, 1526001.859999999403954 ], [ 665243.630000000470318, 1526003.289999998640269 ], [ 665243.630000000470318, 1526003.289999997941777 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "branch_5", "branchtype": "river", "branchorder": 3.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_5", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665243.630000000470318, 1526003.289999997941777 ], [ 665116.950000000419095, 1525983.029999999096617 ], [ 665051.90000000083819, 1525977.32 ], [ 664963.504724813159555, 1526014.666760261869058 ], [ 664918.370000000344589, 1526039.810000000521541 ], [ 664826.210000000428408, 1526041.519999999552965 ], [ 664752.459499345044605, 1526065.157490010838956 ], [ 664672.28994727297686, 1526086.417805780190974 ], [ 664642.852168873418123, 1526095.560649296734482 ], [ 664550.869999999529682, 1526115.410000000149012 ], [ 664474.13, 1526115.7 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "branch_6", "branchtype": "river", "branchorder": 4.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_6", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664474.13, 1526115.7 ], [ 664429.038999999989755, 1526107.098 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "branch_7", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_7", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664429.038999999989755, 1526107.098 ], [ 664272.40999999945052, 1526129.970000000204891 ], [ 664169.979999999864958, 1526140.529999999562278 ], [ 664092.240000000223517, 1526143.2899999988731 ], [ 664057.966296999948099, 1526147.834882 ], [ 664057.966296999948099, 1526147.834882 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "branch_8", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_8", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 666180.040000000037253, 1525894.769999999320135 ], [ 665891.336423385655507, 1526041.311705864733085 ], [ 665733.269999999320135, 1526117.310000000521541 ], [ 665733.269999999320135, 1526117.310000000521541 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "branch_10", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_10", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665733.269999999320135, 1526117.310000000521541 ], [ 665641.789999999804422, 1525937.96000000089407 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "branch_11", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_11", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664789.146172603359446, 1525073.346127192256972 ], [ 665015.157200000365265, 1525576.51439999951981 ], [ 665015.157200000365265, 1525576.514399999286979 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "branch_12", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_12", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665015.157200000365265, 1525576.514399999286979 ], [ 665030.18360000057146, 1525603.506899999454618 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, -{ "type": "Feature", "properties": { "branchid": "branch_13", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_13", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665030.18360000057146, 1525603.506899999454618 ], [ 665243.630000000470318, 1526003.289999997941777 ] ] } } +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "river_1", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_1", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664057.966296999948099, 1526147.834882 ], [ 663918.391924358904362, 1525803.10090322420001 ], [ 663700.482064640615135, 1525466.331120023271069 ], [ 663353.045365229598247, 1525088.417517154943198 ], [ 662879.129516471526586, 1524643.454726681346074 ], [ 662793.794186791637912, 1524515.451732161454856 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "river_2", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_2", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664057.966296999948099, 1526147.834882 ], [ 664218.310854589915834, 1526625.788610660471022 ], [ 664218.310854589915834, 1527005.169120056321844 ], [ 664197.234159623389132, 1527152.705984821310267 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_1", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_1", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665115.699999999953434, 1524944.79 ], [ 665356.868200000026263, 1525406.9835 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_2", "branchorder": 2.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_2", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665356.868200000026263, 1525406.9835 ], [ 665369.906399999978021, 1525431.441199999069795 ], [ 665369.906399999978021, 1525431.4412 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_3", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_3", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665369.906399999978021, 1525431.4412 ], [ 665641.789999999804422, 1525937.96000000089407 ], [ 665641.789999999804422, 1525937.96000000089407 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_4", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_4", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665641.789999999804422, 1525937.96000000089407 ], [ 665560.620547444559634, 1525952.124135404126719 ], [ 665480.575254552299157, 1525953.687039414886385 ], [ 665416.820000000414439, 1525962.189999999245629 ], [ 665346.659376955241896, 1525982.895817694021389 ], [ 665271.309999999706633, 1526001.859999999403954 ], [ 665243.630000000470318, 1526003.289999998640269 ], [ 665243.630000000470318, 1526003.289999997941777 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_5", "branchorder": 3.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_5", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665243.630000000470318, 1526003.289999997941777 ], [ 665116.950000000419095, 1525983.029999999096617 ], [ 665051.90000000083819, 1525977.32 ], [ 664963.504724813159555, 1526014.666760261869058 ], [ 664918.370000000344589, 1526039.810000000521541 ], [ 664826.210000000428408, 1526041.519999999552965 ], [ 664752.459499345044605, 1526065.157490010838956 ], [ 664672.28994727297686, 1526086.417805780190974 ], [ 664642.852168873418123, 1526095.560649296734482 ], [ 664550.869999999529682, 1526115.410000000149012 ], [ 664474.13, 1526115.7 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_6", "branchorder": 4.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_6", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664474.13, 1526115.7 ], [ 664429.038999999989755, 1526107.098 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_7", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_7", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664429.038999999989755, 1526107.098 ], [ 664272.40999999945052, 1526129.970000000204891 ], [ 664169.979999999864958, 1526140.529999999562278 ], [ 664092.240000000223517, 1526143.2899999988731 ], [ 664057.966296999948099, 1526147.834882 ], [ 664057.966296999948099, 1526147.834882 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_8", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_8", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 666180.040000000037253, 1525894.769999999320135 ], [ 665891.336423385655507, 1526041.311705864733085 ], [ 665733.269999999320135, 1526117.310000000521541 ], [ 665733.269999999320135, 1526117.310000000521541 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_10", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_10", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665733.269999999320135, 1526117.310000000521541 ], [ 665641.789999999804422, 1525937.96000000089407 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_11", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_11", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664789.146172603359446, 1525073.346127192256972 ], [ 665015.157200000365265, 1525576.51439999951981 ], [ 665015.157200000365265, 1525576.514399999286979 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_12", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_12", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665015.157200000365265, 1525576.514399999286979 ], [ 665030.18360000057146, 1525603.506899999454618 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_13", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_13", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665030.18360000057146, 1525603.506899999454618 ], [ 665243.630000000470318, 1526003.289999997941777 ] ] } } ] } diff --git a/examples/dflowfm_local/geoms/rivers_nodes.geojson b/examples/dflowfm_local/geoms/rivers_nodes.geojson index be50d994..6e55c5f3 100644 --- a/examples/dflowfm_local/geoms/rivers_nodes.geojson +++ b/examples/dflowfm_local/geoms/rivers_nodes.geojson @@ -2,22 +2,22 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_0", "branch_id": "branch_1", "branchid": "branch_1", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_1" }, "geometry": { "type": "Point", "coordinates": [ 665115.70000000030268, 1524944.7899999988731 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_1", "branch_id": "branch_1", "branchid": "branch_1", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_1" }, "geometry": { "type": "Point", "coordinates": [ 665356.868200001074001, 1525406.983500000322238 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_2", "branch_id": "branch_2", "branchid": "branch_2", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_2" }, "geometry": { "type": "Point", "coordinates": [ 665369.906399999978021, 1525431.441199999069795 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_3", "branch_id": "branch_3", "branchid": "branch_3", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_3" }, "geometry": { "type": "Point", "coordinates": [ 665369.906399999978021, 1525431.441199998836964 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_4", "branch_id": "branch_3", "branchid": "branch_3", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_3" }, "geometry": { "type": "Point", "coordinates": [ 665641.789999999804422, 1525937.96000000089407 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_5", "branch_id": "branch_4", "branchid": "branch_4", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_4" }, "geometry": { "type": "Point", "coordinates": [ 665243.630000000470318, 1526003.289999998640269 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_6", "branch_id": "branch_5", "branchid": "branch_5", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_5" }, "geometry": { "type": "Point", "coordinates": [ 665243.630000000470318, 1526003.289999998174608 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_7", "branch_id": "branch_5", "branchid": "branch_5", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_5" }, "geometry": { "type": "Point", "coordinates": [ 664474.13, 1526115.699999999254942 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_8", "branch_id": "branch_6", "branchid": "branch_6", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_6" }, "geometry": { "type": "Point", "coordinates": [ 664429.038999999407679, 1526107.097999999299645 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_9", "branch_id": "branch_7", "branchid": "branch_7", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_7" }, "geometry": { "type": "Point", "coordinates": [ 664057.966297403792851, 1526147.834882111055776 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_10", "branch_id": "branch_8", "branchid": "branch_8", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_8" }, "geometry": { "type": "Point", "coordinates": [ 666180.040000000037253, 1525894.769999999320135 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_11", "branch_id": "branch_8", "branchid": "branch_8", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_8" }, "geometry": { "type": "Point", "coordinates": [ 665733.269999999320135, 1526117.310000000521541 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_12", "branch_id": "branch_11", "branchid": "branch_11", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_11" }, "geometry": { "type": "Point", "coordinates": [ 664789.146172603359446, 1525073.346127192256972 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_13", "branch_id": "branch_11", "branchid": "branch_11", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_11" }, "geometry": { "type": "Point", "coordinates": [ 665015.157200000365265, 1525576.51439999951981 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_14", "branch_id": "branch_12", "branchid": "branch_12", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_12" }, "geometry": { "type": "Point", "coordinates": [ 665015.157200000365265, 1525576.514399999286979 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_15", "branch_id": "branch_12", "branchid": "branch_12", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_12" }, "geometry": { "type": "Point", "coordinates": [ 665030.18360000057146, 1525603.506899999454618 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_16", "branch_id": "branch_13", "branchid": "branch_13", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_13" }, "geometry": { "type": "Point", "coordinates": [ 665243.630000000470318, 1526003.289999997941777 ] } } +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_0", "branch_id": "branch_1", "branchtype": "river", "branchid": "branch_1", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_1" }, "geometry": { "type": "Point", "coordinates": [ 665115.70000000030268, 1524944.7899999988731 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_1", "branch_id": "branch_1", "branchtype": "river", "branchid": "branch_1", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_1" }, "geometry": { "type": "Point", "coordinates": [ 665356.868200001074001, 1525406.983500000322238 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_2", "branch_id": "branch_2", "branchtype": "river", "branchid": "branch_2", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_2" }, "geometry": { "type": "Point", "coordinates": [ 665369.906399999978021, 1525431.441199999069795 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_3", "branch_id": "branch_3", "branchtype": "river", "branchid": "branch_3", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_3" }, "geometry": { "type": "Point", "coordinates": [ 665369.906399999978021, 1525431.441199998836964 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_4", "branch_id": "branch_3", "branchtype": "river", "branchid": "branch_3", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_3" }, "geometry": { "type": "Point", "coordinates": [ 665641.789999999804422, 1525937.96000000089407 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_5", "branch_id": "branch_4", "branchtype": "river", "branchid": "branch_4", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_4" }, "geometry": { "type": "Point", "coordinates": [ 665243.630000000470318, 1526003.289999998640269 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_6", "branch_id": "branch_5", "branchtype": "river", "branchid": "branch_5", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_5" }, "geometry": { "type": "Point", "coordinates": [ 665243.630000000470318, 1526003.289999998174608 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_7", "branch_id": "branch_5", "branchtype": "river", "branchid": "branch_5", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_5" }, "geometry": { "type": "Point", "coordinates": [ 664474.13, 1526115.699999999254942 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_8", "branch_id": "branch_6", "branchtype": "river", "branchid": "branch_6", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_6" }, "geometry": { "type": "Point", "coordinates": [ 664429.038999999407679, 1526107.097999999299645 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_9", "branch_id": "branch_7", "branchtype": "river", "branchid": "branch_7", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_7" }, "geometry": { "type": "Point", "coordinates": [ 664057.966297403792851, 1526147.834882111055776 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_10", "branch_id": "branch_8", "branchtype": "river", "branchid": "branch_8", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_8" }, "geometry": { "type": "Point", "coordinates": [ 666180.040000000037253, 1525894.769999999320135 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_11", "branch_id": "branch_8", "branchtype": "river", "branchid": "branch_8", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_8" }, "geometry": { "type": "Point", "coordinates": [ 665733.269999999320135, 1526117.310000000521541 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_12", "branch_id": "branch_11", "branchtype": "river", "branchid": "branch_11", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_11" }, "geometry": { "type": "Point", "coordinates": [ 664789.146172603359446, 1525073.346127192256972 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_13", "branch_id": "branch_11", "branchtype": "river", "branchid": "branch_11", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_11" }, "geometry": { "type": "Point", "coordinates": [ 665015.157200000365265, 1525576.51439999951981 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_14", "branch_id": "branch_12", "branchtype": "river", "branchid": "branch_12", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_12" }, "geometry": { "type": "Point", "coordinates": [ 665015.157200000365265, 1525576.514399999286979 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_15", "branch_id": "branch_12", "branchtype": "river", "branchid": "branch_12", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_12" }, "geometry": { "type": "Point", "coordinates": [ 665030.18360000057146, 1525603.506899999454618 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_16", "branch_id": "branch_13", "branchtype": "river", "branchid": "branch_13", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_13" }, "geometry": { "type": "Point", "coordinates": [ 665243.630000000470318, 1526003.289999997941777 ] } } ] } From b3d57f232939fb6838f870d0f4204c93865f9612 Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Tue, 19 Sep 2023 09:45:29 +0200 Subject: [PATCH 06/32] fixes related to model update --- hydromt_delft3dfm/dflowfm.py | 59 ++++++++++++++++++--------- hydromt_delft3dfm/mesh_utils.py | 37 +++++++++++++++++ hydromt_delft3dfm/utils.py | 13 +++--- hydromt_delft3dfm/workflows/helper.py | 2 +- 4 files changed, 85 insertions(+), 26 deletions(-) diff --git a/hydromt_delft3dfm/dflowfm.py b/hydromt_delft3dfm/dflowfm.py index b16d77c4..5bdd4760 100644 --- a/hydromt_delft3dfm/dflowfm.py +++ b/hydromt_delft3dfm/dflowfm.py @@ -3017,10 +3017,16 @@ def read_maps(self) -> Dict[str, Union[xr.Dataset, xr.DataArray]]: self._assert_read_mode # Read initial fields inifield_model = self.dfmmodel.geometry.inifieldfile - if inifield_model is not None: + # seperate 1d and 2d + inifield_model_1d = [ + i for i in inifield_model.initial if "1d" in i.datafiletype + ] + inifield_model_2d = [ + i for i in inifield_model.initial if "2d" in i.datafiletype + ] + if any(inifield_model_2d): # Loop over initial / parameter to read the geotif - inilist = inifield_model.initial.copy() - inilist.extend(inifield_model.parameter) + inilist = inifield_model_2d if len(inilist) > 0: # DFM map names @@ -3204,14 +3210,6 @@ def write_geoms(self, write_mesh_gdf=True) -> None: """Write model geometries to a GeoJSON file at /.""" self._assert_write_mode - # Optional: also write mesh_gdf object - if write_mesh_gdf: - for name, gdf in self.mesh_gdf.items(): - self.set_geoms(gdf, name) - - # Write geojson equivalent of all objects. Note that these files are not directly used when updating the model - super().write_geoms(fn="geoms/{name}.geojson") - # Write dfm files savedir = dirname(join(self.root, self._config_fn)) @@ -3256,6 +3254,27 @@ def write_geoms(self, write_mesh_gdf=True) -> None: ) self.set_config("geometry.structurefile", structures_fn) + # write hydromt + # Optional: also write mesh_gdf object + if write_mesh_gdf: + for name, gdf in self.mesh_gdf.items(): + self.set_geoms(gdf, name) + + # Write geojson equivalent of all objects. Note that these files are not directly used when updating the model + # convert any list in geoms to strings + def convert_lists_to_strings(df): + for column_name in df.columns: + if df[column_name].apply(isinstance, args=(list,)).all(): + df[column_name] = df[column_name].apply( + lambda x: " ".join(f"{x}") if isinstance(x, list) else x + ) + return df + + for name in self.geoms: + self.set_geoms(convert_lists_to_strings(self.geoms[name]), name) + + super().write_geoms(fn="geoms/{name}.geojson") + def read_forcing( self, ) -> None: # FIXME reading of forcing should include boundary, lateral and meteo @@ -3347,10 +3366,12 @@ def read_mesh(self): # FIXME: crs info is not available in dfmmodel, so get it from region.geojson # Cannot use read_geoms yet because for some some geoms (crosssections, manholes) mesh needs to be read first... region_fn = join(self.root, "geoms", "region.geojson") - if isfile(region_fn): - crs = gpd.read_file(region_fn).crs - else: - crs = None + if not self.crs: + if isfile(region_fn): + crs = gpd.read_file(region_fn).crs + self._crs = crs + + crs = self.crs # convert to xugrid mesh = mesh_utils.mesh_from_hydrolib_network(network, crs=crs) @@ -3364,12 +3385,10 @@ def read_mesh(self): # creates branches geometry from network1d if "network1d" in self.mesh_names: - network1d_geometry = self.mesh_gdf["network1d"] network1d_dataset = self.mesh_datasets["network1d"] - # Create the branches GeoDataFrame - branches = network1d_geometry - branches["branchid"] = network1d_dataset["network1d_branch_id"] - branches["branchorder"] = network1d_dataset["network1d_branch_order"] + # Create the branches GeoDataFrame (from geom) + # network1d_geometry = self.mesh_gdf["network1d"] this returns the network + branches = mesh_utils.network1d_geoms_geodataframe(network1d_dataset) # branches["branchtype"] = network1d_dataset["network1d_branch_type"] # might support in the future https://github.com/Deltares/HYDROLIB-core/issues/561 # Add branchtype, properties from branches.gui file diff --git a/hydromt_delft3dfm/mesh_utils.py b/hydromt_delft3dfm/mesh_utils.py index 358a739e..c55528dd 100644 --- a/hydromt_delft3dfm/mesh_utils.py +++ b/hydromt_delft3dfm/mesh_utils.py @@ -4,6 +4,7 @@ from typing import Tuple import geopandas as gpd +from shapely.geometry import LineString import xarray as xr import xugrid as xu from hydrolib.core.dflowfm import Network @@ -19,6 +20,7 @@ "mesh_from_hydrolib_network", "mesh1d_nodes_geodataframe", "network1d_nodes_geodataframe", + "network1d_geoms_geodataframe", ] @@ -408,3 +410,38 @@ def network1d_nodes_geodataframe( ) return network1d_nodes + + +def network1d_geoms_geodataframe( + uds_network1d: xu.UgridDataset, +) -> gpd.GeoDataFrame: + """ + Get network1d as gdp from network1d geoms. + + Parameters + ---------- + uds_network1d : xu.UgridDataset + Network1d UgridDataset including network1d data_vars. + + Returns + ------- + network1d : gpd.GeoDataFrame + Network1d GeoDataFrame. + """ + network1d_geoms = [] + start_index = 0 + for n in uds_network1d["network1d_part_node_count"].values: + x = uds_network1d["network1d_geom_x"][start_index : start_index + n] + y = uds_network1d["network1d_geom_y"][start_index : start_index + n] + start_index += n + points = list(zip(x, y)) + line = LineString(points) + network1d_geoms.append(line) + network1d_geoms = gpd.GeoDataFrame( + geometry=network1d_geoms, + crs=uds_network1d.ugrid.grid.crs, + ) + network1d_geoms["branchid"] = uds_network1d["network1d_branch_id"] + network1d_geoms["branchorder"] = uds_network1d["network1d_branch_order"] + + return network1d_geoms diff --git a/hydromt_delft3dfm/utils.py b/hydromt_delft3dfm/utils.py index 3615b789..4309df11 100644 --- a/hydromt_delft3dfm/utils.py +++ b/hydromt_delft3dfm/utils.py @@ -399,11 +399,14 @@ def write_friction(gdf: gpd.GeoDataFrame, savedir: str) -> List[str]: friction_fns = [] # create a new friction for i, row in frictions.iterrows(): - fric_model = FrictionModel(global_=row.to_dict()) - fric_name = f"{row.frictiontype[0]}-{str(row.frictionvalue).replace('.', 'p')}" - fric_filename = f"{fric_model._filename()}_{fric_name}" + fric_model._ext() - fric_model.filepath = join(savedir, fric_filename) - fric_model.save(fric_model.filepath, recurse=False) + if not np.isnan(row.frictionvalue): + fric_model = FrictionModel(global_=row.to_dict()) + fric_name = ( + f"{row.frictiontype[0]}-{str(row.frictionvalue).replace('.', 'p')}" + ) + fric_filename = f"{fric_model._filename()}_{fric_name}" + fric_model._ext() + fric_model.filepath = join(savedir, fric_filename) + fric_model.save(fric_model.filepath, recurse=False) # save relative path to mdu friction_fns.append(fric_filename) diff --git a/hydromt_delft3dfm/workflows/helper.py b/hydromt_delft3dfm/workflows/helper.py index 4f85832c..3e13880a 100644 --- a/hydromt_delft3dfm/workflows/helper.py +++ b/hydromt_delft3dfm/workflows/helper.py @@ -614,4 +614,4 @@ def get_gdf_from_branches( new_point_geometry = line_geometry.interpolate(row.chainage) df.loc[i, "geometry"] = new_point_geometry - return gpd.GeoDataFrame(df) + return gpd.GeoDataFrame(df, crs=branches.crs) From e3ad51c382c48755fc5b9ddce79e929c295f7c40 Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Tue, 19 Sep 2023 11:21:37 +0200 Subject: [PATCH 07/32] more fixes --- hydromt_delft3dfm/dflowfm.py | 2 +- hydromt_delft3dfm/utils.py | 3 +++ hydromt_delft3dfm/workflows/crosssections.py | 2 +- 3 files changed, 5 insertions(+), 2 deletions(-) diff --git a/hydromt_delft3dfm/dflowfm.py b/hydromt_delft3dfm/dflowfm.py index 5bdd4760..02e88d18 100644 --- a/hydromt_delft3dfm/dflowfm.py +++ b/hydromt_delft3dfm/dflowfm.py @@ -3264,7 +3264,7 @@ def write_geoms(self, write_mesh_gdf=True) -> None: # convert any list in geoms to strings def convert_lists_to_strings(df): for column_name in df.columns: - if df[column_name].apply(isinstance, args=(list,)).all(): + if df[column_name].apply(isinstance, args=(list,)).any(): df[column_name] = df[column_name].apply( lambda x: " ".join(f"{x}") if isinstance(x, list) else x ) diff --git a/hydromt_delft3dfm/utils.py b/hydromt_delft3dfm/utils.py index 4309df11..9df8ae62 100644 --- a/hydromt_delft3dfm/utils.py +++ b/hydromt_delft3dfm/utils.py @@ -545,6 +545,9 @@ def write_manholes(gdf: gpd.GeoDataFrame, savedir: str) -> str: storage_fn: str relative path to storage nodes file. """ + if gdf.columns.__contains__("numlevels"): + gdf["numlevels"] = gdf["numlevels"].astype("Int64") + storagenodes = StorageNodeModel(storagenode=gdf.to_dict("records")) storage_fn = storagenodes._filename() + ".ini" diff --git a/hydromt_delft3dfm/workflows/crosssections.py b/hydromt_delft3dfm/workflows/crosssections.py index 3284ee76..d4dff5f8 100644 --- a/hydromt_delft3dfm/workflows/crosssections.py +++ b/hydromt_delft3dfm/workflows/crosssections.py @@ -599,7 +599,7 @@ def set_point_crosssections( elif shape == "yz": yz_crs = crosssections.loc[crosssections["shape"] == shape, :] check_gpd_attributes( - trapezoid_crs, + yz_crs, required_columns=[ "branch_id", "branch_offset", From c03ee99446d0879cd6e4a9020a4a60ad317a8200 Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Wed, 20 Sep 2023 05:05:52 +0200 Subject: [PATCH 08/32] bug fixing 1d laterals --- hydromt_delft3dfm/dflowfm.py | 41 ++++++++++++++++++----- hydromt_delft3dfm/utils.py | 19 ++++++----- hydromt_delft3dfm/workflows/boundaries.py | 2 +- 3 files changed, 45 insertions(+), 17 deletions(-) diff --git a/hydromt_delft3dfm/dflowfm.py b/hydromt_delft3dfm/dflowfm.py index 02e88d18..ed71a62e 100644 --- a/hydromt_delft3dfm/dflowfm.py +++ b/hydromt_delft3dfm/dflowfm.py @@ -1647,7 +1647,6 @@ def _read_laterals(self, laterals_geodataset_fn): ), # only select data within region of interest variables=["lateral_discharge"], time_tuple=(tstart, tstop), - crs=self.crs.to_epsg(), # assume model crs if none defined ).rename("lateral_discharge") # error if time mismatch if np.logical_and( @@ -1661,7 +1660,7 @@ def _read_laterals(self, laterals_geodataset_fn): ) # reproject if needed and convert to location if da_lat.vector.crs != self.crs: - da_lat.vector.to_crs(self.crs) + da_lat = da_lat.vector.to_crs(self.crs) # get geom gdf_laterals = da_lat.vector.to_gdf(reducer=np.mean) elif ( @@ -1678,6 +1677,29 @@ def _read_laterals(self, laterals_geodataset_fn): da_lat = None return gdf_laterals, da_lat + def _snap_geom_to_branches_and_drop_nonsnapped( + self, branches: gpd.GeoDataFrame, geoms: gpd.GeoDataFrame, snap_offset=0.0 + ): + """Snaps geoms to branches and drop the ones that are not snapped. + Returns snapped geoms with branchid and chainage. + branches must have branchid. + """ + workflows.find_nearest_branch( + branches=branches, + geometries=geoms, + maxdist=snap_offset, + ) + geoms = geoms.rename( + columns={"branch_id": "branchid", "branch_offset": "chainage"} + ) + + # drop ones non snapped + _drop_geoms = geoms["chainage"].isna() + if any(_drop_geoms): + self.logger.debug(f"Unable to snap to branches: {geoms[_drop_geoms].index}") + + return geoms[~_drop_geoms] + def setup_1dlateral_from_points( self, laterals_geodataset_fn: str = None, @@ -1731,15 +1753,15 @@ def setup_1dlateral_from_points( gdf_laterals, da_lat = self._read_laterals(laterals_geodataset_fn) # snap laterlas to selected branches - workflows.find_nearest_branch( + gdf_laterals = self._snap_geom_to_branches_and_drop_nonsnapped( branches=network_by_branchtype.set_index("branchid"), - geometries=gdf_laterals, - maxdist=snap_offset, - ) - gdf_laterals = gdf_laterals.rename( - columns={"branch_id": "branchid", "branch_offset": "chainage"} + geoms=gdf_laterals, + snap_offset=snap_offset, ) + if len(gdf_laterals) == 0: + return None + # 2. Compute lateral dataarray da_out = workflows.compute_forcing_values_points( gdf=gdf_laterals, @@ -1792,6 +1814,9 @@ def setup_1dlateral_from_polygons( # 1. read lateral geodataset gdf_laterals, da_lat = self._read_laterals(laterals_geodataset_fn) + if len(gdf_laterals) == 0: + return None + # 2. Compute lateral dataarray da_out = workflows.compute_forcing_values_polygon( gdf=gdf_laterals, diff --git a/hydromt_delft3dfm/utils.py b/hydromt_delft3dfm/utils.py index 9df8ae62..530c135e 100644 --- a/hydromt_delft3dfm/utils.py +++ b/hydromt_delft3dfm/utils.py @@ -914,14 +914,11 @@ def write_1dlateral(forcing: Dict, savedir: str = None, ext_fn: str = None) -> T ext["branchid"] = da.sel(index=i).coords["branchid"].item() ext["chainage"] = da.sel(index=i).coords["chainage"].item() elif "numcoordinates" in da.coords: # for polygon laterals - ext["xcoordinates"] = da.sel(index=i)[ - "xcoordinates" - ].values.tolist() - ext["ycoordinates"] = da.sel(index=i)[ - "ycoordinates" - ].values.tolist() + xs = da.sel(index=i)["xcoordinates"].values.tolist() + ys = da.sel(index=i)["ycoordinates"].values.tolist() + ext["xcoordinates"] = [x for x in xs if not np.isnan(x)] + ext["ycoordinates"] = [y for y in ys if not np.isnan(y)] ext["numcoordinates"] = len(ext["ycoordinates"]) - da = da.isel(numcoordinates=0) # drop coordinates else: raise ValueError("Not supported.") extdict.append(ext) @@ -944,7 +941,13 @@ def write_1dlateral(forcing: Dict, savedir: str = None, ext_fn: str = None) -> T bc.pop("time_unit") # time/value datablock bc["datablock"] = [ - [t, x] for t, x in zip(da.time.values, da.sel(index=i).values) + [t, x] + for t, x in zip( + da.time.values, + np.unique( + da.sel(index=i).values + ), # get the unique value to reduce polygon dimention + ) ] bc.pop("quantity") bc.pop("units") diff --git a/hydromt_delft3dfm/workflows/boundaries.py b/hydromt_delft3dfm/workflows/boundaries.py index 0fb7129d..3ae88c75 100644 --- a/hydromt_delft3dfm/workflows/boundaries.py +++ b/hydromt_delft3dfm/workflows/boundaries.py @@ -627,7 +627,7 @@ def _standardize_forcing_timeindexes(da): logger.error("does not support non-equidistant time-series.") freq_name = _TIMESTR[freq] freq_step = getattr(dt.components, freq_name) - bd_times = np.array([(i * freq_step) for i in range(len(da.time))]) + bd_times = np.array([float(i * freq_step) for i in range(len(da.time))]) if multiplier == 24: bd_times = np.array([(i * freq_step * multiplier) for i in range(len(da.time))]) freq_name = "hours" From d6482c573d58c656c475df06e63a16e6a1f3bfef Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Wed, 20 Sep 2023 07:40:32 +0200 Subject: [PATCH 09/32] bugfixing 1d forcing --- hydromt_delft3dfm/dflowfm.py | 91 +++++++++-------------- hydromt_delft3dfm/utils.py | 43 ++++++----- hydromt_delft3dfm/workflows/boundaries.py | 27 +------ 3 files changed, 61 insertions(+), 100 deletions(-) diff --git a/hydromt_delft3dfm/dflowfm.py b/hydromt_delft3dfm/dflowfm.py index ed71a62e..aa1fd47b 100644 --- a/hydromt_delft3dfm/dflowfm.py +++ b/hydromt_delft3dfm/dflowfm.py @@ -1575,45 +1575,20 @@ def setup_1dboundary( By default 0.1, a small snapping is applied to avoid precision errors. """ self.logger.info(f"Preparing 1D {boundary_type} boundaries for {branch_type}.") + + # 1. get potential boundary locations based on branch_type and boundary_type boundaries = workflows.get_boundaries_with_nodeid( self.branches, mesh_utils.network1d_nodes_geodataframe(self.mesh_datasets["network1d"]), ) - refdate, tstart, tstop = self.get_model_time() # time slice - - # 1. get potential boundary locations based on branch_type and boundary_type boundaries_branch_type = workflows.select_boundary_type( boundaries, branch_type, boundary_type, boundary_locs ) # 2. read boundary from user data - if boundaries_geodataset_fn is not None: - da_bnd = self.data_catalog.get_geodataset( - boundaries_geodataset_fn, - geom=boundaries.buffer( - snap_offset - ), # only select data close to the boundary of the model region - variables=[boundary_type], - time_tuple=(tstart, tstop), - crs=self.crs.to_epsg(), # assume model crs if none defined - ).rename(boundary_type) - # error if time mismatch - if np.logical_and( - pd.to_datetime(da_bnd.time.values[0]) == pd.to_datetime(tstart), - pd.to_datetime(da_bnd.time.values[-1]) == pd.to_datetime(tstop), - ): - pass - else: - self.logger.error( - "forcing has different start and end time. Please check the forcing file. support yyyy-mm-dd HH:MM:SS. " - ) - # reproject if needed and convert to location - if da_bnd.vector.crs != self.crs: - da_bnd.vector.to_crs(self.crs) - elif boundaries_timeseries_fn is not None: - raise NotImplementedError() - else: - da_bnd = None + gdf_bnds, da_bnd = self._read_forcing_geodataset( + boundaries_geodataset_fn, boundary_type + ) # 3. Derive DataArray with boundary values at boundary locations in boundaries_branch_type da_out = workflows.compute_boundary_values( @@ -1631,27 +1606,29 @@ def setup_1dboundary( da_out, name=f"boundary1d_{da_out.name}_{branch_type}" ) # FIXME: this format cannot be read back due to lack of branch type info from model files - def _read_laterals(self, laterals_geodataset_fn): - """Reads laterals""" + def _read_forcing_geodataset( + self, forcing_geodataset_fn: Union[str, Path], forcing_name: str = "discharge" + ): + """Read forcing geodataset.""" refdate, tstart, tstop = self.get_model_time() # time slice if ( - laterals_geodataset_fn is not None - and self.data_catalog[laterals_geodataset_fn].data_type == "GeoDataset" + forcing_geodataset_fn is not None + and self.data_catalog[forcing_geodataset_fn].data_type == "GeoDataset" ): - da_lat = self.data_catalog.get_geodataset( - laterals_geodataset_fn, + da = self.data_catalog.get_geodataset( + forcing_geodataset_fn, geom=self.region.buffer( - self._network_snap_offset - ), # only select data within region of interest - variables=["lateral_discharge"], + 1000 + ), # only select data within region of interest (large region for forcing) + variables=[forcing_name], time_tuple=(tstart, tstop), - ).rename("lateral_discharge") + ).rename(forcing_name) # error if time mismatch if np.logical_and( - pd.to_datetime(da_lat.time.values[0]) == pd.to_datetime(tstart), - pd.to_datetime(da_lat.time.values[-1]) == pd.to_datetime(tstop), + pd.to_datetime(da.time.values[0]) == pd.to_datetime(tstart), + pd.to_datetime(da.time.values[-1]) == pd.to_datetime(tstop), ): pass else: @@ -1659,23 +1636,23 @@ def _read_laterals(self, laterals_geodataset_fn): "forcing has different start and end time. Please check the forcing file. support yyyy-mm-dd HH:MM:SS. " ) # reproject if needed and convert to location - if da_lat.vector.crs != self.crs: - da_lat = da_lat.vector.to_crs(self.crs) + if da.vector.crs != self.crs: + da = da.vector.to_crs(self.crs) # get geom - gdf_laterals = da_lat.vector.to_gdf(reducer=np.mean) + gdf = da.vector.to_gdf(reducer=np.mean) elif ( - laterals_geodataset_fn is not None - and self.data_catalog[laterals_geodataset_fn].data_type == "GeoDataFrame" + forcing_geodataset_fn is not None + and self.data_catalog[forcing_geodataset_fn].data_type == "GeoDataFrame" ): - gdf_laterals = self.data_catalog.get_geodataframe( - laterals_geodataset_fn, + gdf = self.data_catalog.get_geodataframe( + forcing_geodataset_fn, geom=self.region.buffer(self._network_snap_offset), ) - da_lat = None + da = None else: - gdf_laterals = None - da_lat = None - return gdf_laterals, da_lat + gdf = None + da = None + return gdf, da def _snap_geom_to_branches_and_drop_nonsnapped( self, branches: gpd.GeoDataFrame, geoms: gpd.GeoDataFrame, snap_offset=0.0 @@ -1750,7 +1727,9 @@ def setup_1dlateral_from_points( network_by_branchtype = self.staticgeoms[f"{branch_type}s"] # 1. read lateral geodataset and snap to network - gdf_laterals, da_lat = self._read_laterals(laterals_geodataset_fn) + gdf_laterals, da_lat = self._read_forcing_geodataset( + laterals_geodataset_fn, "lateral_discharge" + ) # snap laterlas to selected branches gdf_laterals = self._snap_geom_to_branches_and_drop_nonsnapped( @@ -1812,7 +1791,9 @@ def setup_1dlateral_from_polygons( self.logger.info(f"Preparing 1D laterals for polygons.") # 1. read lateral geodataset - gdf_laterals, da_lat = self._read_laterals(laterals_geodataset_fn) + gdf_laterals, da_lat = self._read_forcing_geodataset( + laterals_geodataset_fn, "lateral_discharge" + ) if len(gdf_laterals) == 0: return None diff --git a/hydromt_delft3dfm/utils.py b/hydromt_delft3dfm/utils.py index 530c135e..4a1f56c0 100644 --- a/hydromt_delft3dfm/utils.py +++ b/hydromt_delft3dfm/utils.py @@ -709,18 +709,8 @@ def write_1dboundary(forcing: Dict, savedir: str = None, ext_fn: str = None) -> bcdict.append(bc) # write forcing file - for bc in bcdict: - try: - ForcingModel( - forcing=[ - bc for bc in bcdict if bc["name"] == "481349.951956_8041528.002583" - ] - ) - except: - raise ValueError(f"Error in boundary forcing {bc['name']}") - forcing_model = ForcingModel(forcing=bcdict) - forcing_fn = f'boundaryconditions1d_{ext["quantity"]}.bc' + forcing_fn = f"boundarycondition1d.bc" forcing_model.save(join(savedir, forcing_fn), recurse=True) # add forcingfile to ext, note each node needs a forcingfile @@ -846,7 +836,7 @@ def read_1dlateral( pass elif any(df.branchid.values): _df = df[~df.branchid.isna()] - _data = data[~df.numcoordinates.isna()] + _data = data[~df.numcoordinates.isnull()] # update coords _df["geometry"] = [ branches.set_index("branchid") @@ -940,22 +930,31 @@ def write_1dlateral(forcing: Dict, savedir: str = None, ext_fn: str = None) -> T ] bc.pop("time_unit") # time/value datablock - bc["datablock"] = [ - [t, x] - for t, x in zip( - da.time.values, - np.unique( - da.sel(index=i).values - ), # get the unique value to reduce polygon dimention - ) - ] + _d = da.sel(index=i).values + if len(_d.shape) == 1: + # point + bc["datablock"] = [ + [t, x] + for t, x in zip(da.time.values, da.sel(index=i).values) + ] + else: + # polygon + bc["datablock"] = [ + [t, x] + for t, x in zip( + da.time.values, + np.unique( + da.sel(index=i).values, axis=1 + ), # get the unique value to reduce polygon dimention + ) + ] bc.pop("quantity") bc.pop("units") bcdict.append(bc) # write forcing file forcing_model = ForcingModel(forcing=bcdict) - forcing_fn = f'lateral1d_{ext["quantity"]}.bc' + forcing_fn = f"lateral1d.bc" forcing_model.save(join(savedir, forcing_fn), recurse=True) # add forcingfile to ext, note forcing file is called discharge for lateral diff --git a/hydromt_delft3dfm/workflows/boundaries.py b/hydromt_delft3dfm/workflows/boundaries.py index 3ae88c75..d50f4421 100644 --- a/hydromt_delft3dfm/workflows/boundaries.py +++ b/hydromt_delft3dfm/workflows/boundaries.py @@ -262,29 +262,11 @@ def compute_boundary_values( max_dist=snap_offset, overwrite=True, ) + gdf_bnd = gdf_bnd[~gdf_bnd["nodeid"].isna()] + da_bnd = da_bnd.sel(index=gdf_bnd.index) - # get boundary data freq in seconds - _TIMESTR = {"D": "days", "H": "hours", "T": "minutes", "S": "seconds"} - dt = pd.to_timedelta((da_bnd.time[1].values - da_bnd.time[0].values)) - freq = dt.resolution_string - multiplier = 1 - if freq == "D": - logger.warning( - "time unit days is not supported by the current GUI version: 2022.04" - ) # converting to hours as temporary solution # FIXME: day is converted to hours temporarily - multiplier = 24 - if len( - pd.date_range(da_bnd.time[0].values, da_bnd.time[-1].values, freq=dt) - ) != len(da_bnd.time): - logger.error("does not support non-equidistant time-series.") - freq_name = _TIMESTR[freq] - freq_step = getattr(dt.components, freq_name) - bd_times = np.array([(i * freq_step) for i in range(len(da_bnd.time))]) - if multiplier == 24: - bd_times = np.array( - [(i * freq_step * multiplier) for i in range(len(da_bnd.time))] - ) - freq_name = "hours" + # get forcing data time indes + bd_times, freq_name = _standardize_forcing_timeindexes(da_bnd) # instantiate xr.DataArray for bnd data da_out = xr.DataArray( @@ -704,7 +686,6 @@ def compute_forcing_values_points( time_unit=f"{freq_name} since {pd.to_datetime(da.time[0].values)}", # support only yyyy-mm-dd HH:MM:SS ), ) - # fill in na using default da_out = da_out.fillna(forcing_value) From 7f450d79c54f2725c84931abea7636726f33838a Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Wed, 20 Sep 2023 09:37:47 +0200 Subject: [PATCH 10/32] bugfixing boundaries --- hydromt_delft3dfm/dflowfm.py | 22 ++++++++++++++++------ 1 file changed, 16 insertions(+), 6 deletions(-) diff --git a/hydromt_delft3dfm/dflowfm.py b/hydromt_delft3dfm/dflowfm.py index aa1fd47b..000e6310 100644 --- a/hydromt_delft3dfm/dflowfm.py +++ b/hydromt_delft3dfm/dflowfm.py @@ -1577,12 +1577,8 @@ def setup_1dboundary( self.logger.info(f"Preparing 1D {boundary_type} boundaries for {branch_type}.") # 1. get potential boundary locations based on branch_type and boundary_type - boundaries = workflows.get_boundaries_with_nodeid( - self.branches, - mesh_utils.network1d_nodes_geodataframe(self.mesh_datasets["network1d"]), - ) boundaries_branch_type = workflows.select_boundary_type( - boundaries, branch_type, boundary_type, boundary_locs + self.boundaries, branch_type, boundary_type, boundary_locs ) # 2. read boundary from user data @@ -1751,7 +1747,7 @@ def setup_1dlateral_from_points( logger=self.logger, ) - # 4. set boundaries + # 4. set laterals self.set_forcing(da_out, name=f"lateral1d_points") def setup_1dlateral_from_polygons( @@ -3643,6 +3639,20 @@ def closedsystem(self): gdf = gpd.GeoDataFrame() return gdf + @property + def boundaries(self): + if "boundaries" not in self.geoms: + self.set_geoms( + workflows.get_boundaries_with_nodeid( + self.branches, + mesh_utils.network1d_nodes_geodataframe( + self.mesh_datasets["network1d"] + ), + ), + "boundaries", + ) + return self.geoms["boundaries"] + def get_model_time(self): """Return (refdate, tstart, tstop) tuple with parsed model reference datem start and end time.""" refdate = datetime.strptime(str(self.get_config("time.refdate")), "%Y%m%d") From caa258eaa5132d67cd3a74aa392bf1f5425574bb Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Wed, 20 Sep 2023 10:59:02 +0200 Subject: [PATCH 11/32] bugfixing crs --- hydromt_delft3dfm/dflowfm.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/hydromt_delft3dfm/dflowfm.py b/hydromt_delft3dfm/dflowfm.py index 000e6310..c3b65ef3 100644 --- a/hydromt_delft3dfm/dflowfm.py +++ b/hydromt_delft3dfm/dflowfm.py @@ -3368,7 +3368,7 @@ def read_mesh(self): # FIXME: crs info is not available in dfmmodel, so get it from region.geojson # Cannot use read_geoms yet because for some some geoms (crosssections, manholes) mesh needs to be read first... region_fn = join(self.root, "geoms", "region.geojson") - if not self.crs: + if not self._crs: if isfile(region_fn): crs = gpd.read_file(region_fn).crs self._crs = crs From 95c5fa10f2beb5f3b2c2eca56449c083d821bc65 Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Thu, 21 Sep 2023 04:31:36 +0200 Subject: [PATCH 12/32] bugfixing frictions (in progress) --- hydromt_delft3dfm/dflowfm.py | 2 +- hydromt_delft3dfm/utils.py | 69 ++++++++++++++++++++---------------- 2 files changed, 40 insertions(+), 31 deletions(-) diff --git a/hydromt_delft3dfm/dflowfm.py b/hydromt_delft3dfm/dflowfm.py index c3b65ef3..e9bc75bb 100644 --- a/hydromt_delft3dfm/dflowfm.py +++ b/hydromt_delft3dfm/dflowfm.py @@ -3188,7 +3188,7 @@ def read_geoms(self) -> None: # FIXME: gives an error when only 2D model. crosssections = utils.read_crosssections(self.branches, self.dfmmodel) # Add friction properties from roughness files - self.logger.info("Reading friction files") + # self.logger.info("Reading friction files") crosssections = utils.read_friction(crosssections, self.dfmmodel) self.set_geoms(crosssections, "crosssections") diff --git a/hydromt_delft3dfm/utils.py b/hydromt_delft3dfm/utils.py index 4a1f56c0..7726ca5b 100644 --- a/hydromt_delft3dfm/utils.py +++ b/hydromt_delft3dfm/utils.py @@ -208,7 +208,6 @@ def _list2Str(lst): _gdf_crsdef = df_crsdef.rename( columns={c: f"crsdef_{c}" for c in df_crsdef.columns if c != "crs_id"} ) - _gdf_crsdef = _gdf_crsdef.rename(columns={"crsdef_frictionid": "crsdef_frictionid"}) # Continue with locs to get the locations and branches id crsloc = fm_model.geometry.crosslocfile @@ -329,10 +328,8 @@ def read_friction(gdf: gpd.GeoDataFrame, fm_model: FMModel) -> gpd.GeoDataFrame: gdf containing the crosssections updated with the friction params """ fric_list = fm_model.geometry.frictfile - # TODO: check if read/write crosssections can automatically parse it? - # Create dictionnaries with all attributes from fricfile - # For now assume global only + # global only fricval = dict() frictype = dict() for i in range(len(fric_list)): @@ -343,18 +340,45 @@ def read_friction(gdf: gpd.GeoDataFrame, fm_model: FMModel) -> gpd.GeoDataFrame: frictype[fric_list[i].global_[j].frictionid] = ( fric_list[i].global_[j].frictiontype ) + # Create friction value and type by replacing frictionid values with dict gdf_out = gdf.copy() if "crsdef_frictionid" in gdf_out: gdf_out["frictionvalue"] = gdf_out["crsdef_frictionid"] - elif "crsdef_frictionids" in gdf_out: - gdf_out["frictionvalue"] = gdf_out["crsdef_frictionids"] - gdf_out["frictionvalue"] = gdf_out["frictionvalue"].replace(fricval) - if "crsdef_frictionid" in gdf_out: gdf_out["frictiontype"] = gdf_out["crsdef_frictionid"] - elif "crsdef_frictionids" in gdf_out: - gdf_out["frictiontype"] = gdf_out["crsdef_frictionids"] + if "crsdef_frictionids" in gdf_out: + gdf_out["frictionvalue"] = gdf_out["frictionvalue"].combine_first( + gdf_out["crsdef_frictionids"] + ) + gdf_out["frictiontype"] = gdf_out["frictiontype"].combine_first( + gdf_out["crsdef_frictionids"] + ) + gdf_out["frictionvalue"] = gdf_out["frictionvalue"].replace(fricval) gdf_out["frictiontype"] = gdf_out["frictiontype"].replace(frictype) + # remain nan to be filled with branch roughness + + # try add branch (# TODO improvement - only support one value per branch for now) + fricval = dict() + frictype = dict() + for i in range(len(fric_list)): + for j in range(len(fric_list[i].branch)): + fricval[fric_list[i].branch[j].branchid] = np.unique( + fric_list[i].branch[j].frictionvalues + )[0] + frictype[fric_list[i].branch[j].branchid] = ( + fric_list[i].branch[j].frictiontype + ) + fric_df = pd.DataFrame( + { + "frictionvalue": fricval, + "frictiontype": frictype, + "frictionid": {i: i for i in fricval}, + } + ).reset_index() + gdf_out = gdf_out.combine_first(fric_df) + gdf_out["frictionvalue"] = gdf_out["frictionvalue"].combine_first( + fric_df["frictionvalue"] + ) return gdf_out @@ -375,27 +399,12 @@ def write_friction(gdf: gpd.GeoDataFrame, savedir: str) -> List[str]: friction_fns: List of str list of relative filepaths to friction files. """ - friction_keys = ( - ["crsdef_frictionid", "frictionvalue", "frictiontype"] - if "crsdef_frictionid" in gdf - else ["frictionvalue", "frictiontype", "crsdef_frictionids"] + frictions = gdf.rename( + columns={"crsdef_frictionids": "frictionids", "crsdef_frictionid": "frictionid"} + ) + frictions = frictions.drop_duplicates(subset=["frictionid", "frictionids"]).dropna( + how="all" ) - frictions = gdf[friction_keys] - if "crsdef_frictionid" in frictions: - # Remove nan - frictions = frictions.rename(columns={"crsdef_frictionid": "frictionid"}) - frictions = frictions.dropna(subset="frictionid") - # For xyz crosssections, column name is frictionids instead of frictionid - if "crsdef_frictionids" in gdf: - # For now assume unique and not list - frictionsxyz = gdf - # frictionsxyz = gdf[["crsdef_frictionids", "frictionvalue", "frictiontype"]] - frictionsxyz = frictionsxyz.dropna(subset="crsdef_frictionids") - frictionsxyz = frictionsxyz.rename(columns={"crsdef_frictionids": "frictionid"}) - frictions = pd.concat([frictions, frictionsxyz]) - if "frictionid" in frictions: - frictions = frictions.drop_duplicates(subset="frictionid") - friction_fns = [] # create a new friction for i, row in frictions.iterrows(): From 4a83bc8b654a24cadccb86ab89c9fa8422b50b5b Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Thu, 21 Sep 2023 10:47:37 +0200 Subject: [PATCH 13/32] bugfixing friction --- hydromt_delft3dfm/utils.py | 52 +++++++++++++------------------------- 1 file changed, 18 insertions(+), 34 deletions(-) diff --git a/hydromt_delft3dfm/utils.py b/hydromt_delft3dfm/utils.py index 7726ca5b..2dbece64 100644 --- a/hydromt_delft3dfm/utils.py +++ b/hydromt_delft3dfm/utils.py @@ -193,6 +193,10 @@ def _list2Str(lst): # convertion needed for xyz/zw crossections # convert list to str () df_crsdef = df_crsdef.applymap(lambda x: _list2Str(x)) + # except for frictionids + df_crsdef["frictionids"] = df_crsdef["frictionids"].str.replace( + " ", ";" + ) # comma list sperated # convert float to int int_columns = list( set(df_crsdef.columns).intersection(("xyzcount", "sectioncount")) @@ -347,39 +351,20 @@ def read_friction(gdf: gpd.GeoDataFrame, fm_model: FMModel) -> gpd.GeoDataFrame: gdf_out["frictionvalue"] = gdf_out["crsdef_frictionid"] gdf_out["frictiontype"] = gdf_out["crsdef_frictionid"] if "crsdef_frictionids" in gdf_out: - gdf_out["frictionvalue"] = gdf_out["frictionvalue"].combine_first( - gdf_out["crsdef_frictionids"] - ) - gdf_out["frictiontype"] = gdf_out["frictiontype"].combine_first( - gdf_out["crsdef_frictionids"] + _do_not_support = ( + gdf_out["crsdef_frictionids"].str.split(";").apply(np.count_nonzero) > 1 ) + gdf_out.loc[~_do_not_support, "crsdef_frictionid"] = gdf_out.loc[ + ~_do_not_support, "crsdef_frictionids" + ].combine_first(gdf_out.loc[~_do_not_support, "crsdef_frictionids"]) + gdf_out.loc[~_do_not_support, "frictionvalue"] = gdf_out.loc[ + ~_do_not_support, "frictionvalue" + ].combine_first(gdf_out.loc[~_do_not_support, "crsdef_frictionids"]) + gdf_out.loc[~_do_not_support, "frictiontype"] = gdf_out.loc[ + ~_do_not_support, "frictiontype" + ].combine_first(gdf_out.loc[~_do_not_support, "crsdef_frictionids"]) gdf_out["frictionvalue"] = gdf_out["frictionvalue"].replace(fricval) gdf_out["frictiontype"] = gdf_out["frictiontype"].replace(frictype) - # remain nan to be filled with branch roughness - - # try add branch (# TODO improvement - only support one value per branch for now) - fricval = dict() - frictype = dict() - for i in range(len(fric_list)): - for j in range(len(fric_list[i].branch)): - fricval[fric_list[i].branch[j].branchid] = np.unique( - fric_list[i].branch[j].frictionvalues - )[0] - frictype[fric_list[i].branch[j].branchid] = ( - fric_list[i].branch[j].frictiontype - ) - fric_df = pd.DataFrame( - { - "frictionvalue": fricval, - "frictiontype": frictype, - "frictionid": {i: i for i in fricval}, - } - ).reset_index() - gdf_out = gdf_out.combine_first(fric_df) - gdf_out["frictionvalue"] = gdf_out["frictionvalue"].combine_first( - fric_df["frictionvalue"] - ) - return gdf_out @@ -408,7 +393,7 @@ def write_friction(gdf: gpd.GeoDataFrame, savedir: str) -> List[str]: friction_fns = [] # create a new friction for i, row in frictions.iterrows(): - if not np.isnan(row.frictionvalue): + if isinstance(row.frictionvalue, float) and not np.isnan(row.frictionvalue): fric_model = FrictionModel(global_=row.to_dict()) fric_name = ( f"{row.frictiontype[0]}-{str(row.frictionvalue).replace('.', 'p')}" @@ -416,9 +401,8 @@ def write_friction(gdf: gpd.GeoDataFrame, savedir: str) -> List[str]: fric_filename = f"{fric_model._filename()}_{fric_name}" + fric_model._ext() fric_model.filepath = join(savedir, fric_filename) fric_model.save(fric_model.filepath, recurse=False) - - # save relative path to mdu - friction_fns.append(fric_filename) + # save relative path to mdu + friction_fns.append(fric_filename) return friction_fns From fc2233e5e1044f460bd155f90251060160fcf461 Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Thu, 21 Sep 2023 11:38:21 +0200 Subject: [PATCH 14/32] fix tests --- examples/dflowfm_local/dflowfm/DFlowFM.mdu | 104 +- examples/dflowfm_local/dflowfm/bnd.ext | 8 +- examples/dflowfm_local/dflowfm/fm_net.nc | Bin 152476 -> 152476 bytes examples/dflowfm_local/dimr_config.xml | 2 +- .../dflowfm_local/geoms/boundaries.geojson | 24 +- examples/dflowfm_local/geoms/branches.geojson | 56 +- examples/dflowfm_local/geoms/bridges.geojson | 4 +- examples/dflowfm_local/geoms/culverts.geojson | 2 +- examples/dflowfm_local/geoms/manholes.geojson | 28 +- .../dflowfm_local/geoms/pipe_nodes.geojson | 40 +- examples/dflowfm_local/geoms/pipes.geojson | 28 +- examples/dflowfm_local/geoms/rivers.geojson | 28 +- .../dflowfm_local/geoms/rivers_nodes.geojson | 34 +- examples/dflowfm_piave/dflowfm/DFlowFM.mdu | 104 +- examples/dflowfm_piave/dflowfm/bnd.ext | 8 +- examples/dflowfm_piave/dflowfm/fieldFile.ini | 2 +- examples/dflowfm_piave/dflowfm/fm_net.nc | Bin 887400 -> 887400 bytes examples/dflowfm_piave/dimr_config.xml | 2 +- .../dflowfm_piave/geoms/boundaries.geojson | 64 +- examples/dflowfm_piave/geoms/branches.geojson | 2014 ++++++++--------- examples/dflowfm_piave/geoms/pipes.geojson | 2002 ++++++++-------- examples/dflowfm_piave/geoms/rivers.geojson | 12 +- .../dflowfm_piave/geoms/rivers_nodes.geojson | 12 +- hydromt_delft3dfm/utils.py | 33 +- 24 files changed, 2310 insertions(+), 2301 deletions(-) diff --git a/examples/dflowfm_local/dflowfm/DFlowFM.mdu b/examples/dflowfm_local/dflowfm/DFlowFM.mdu index 57b2cb92..1876140e 100644 --- a/examples/dflowfm_local/dflowfm/DFlowFM.mdu +++ b/examples/dflowfm_local/dflowfm/DFlowFM.mdu @@ -9,59 +9,59 @@ autoStart = 0 # Autostart simulation after loading MDU o pathsRelativeToParent = 0 # Whether or not (1/0) to resolve file names (e.g. inside the *.ext file) relative to their direct parent, instead of to the toplevel MDU working dir [Geometry] -netFile = fm_net.nc # The net file <*_net.nc> -bathymetryFile = # Removed since March 2022. See [geometry] keyword BedLevelFile. -dryPointsFile = # Dry points file <*.xyz>, third column dummy z values, or polygon file <*.pol>. -structureFile = structures.ini # File <*.ini> containing list of hydraulic structures. -iniFieldFile = fieldFile.ini # Initial and parameter field file <*.ini>. -waterLevIniFile = # Initial water levels sample file <*.xyz>. -landBoundaryFile = # Only for plotting. -thinDamFile = # <*_thd.pli>, Polyline(s) for tracing thin dams. -fixedWeirFile = # <*_fxw.pliz>, Polyline(s) x, y, z, z = fixed weir top levels (formerly fixed weir). -pillarFile = # <*_pillar.pliz>, Polyline file containing four colums with x, y, diameter and Cd coefficient for bridge pillars. -useCaching = 0 # Use caching for geometrical/network-related items (0: no, 1: yes) (section C.19). -vertPlizFile = # <*_vlay.pliz>), = pliz with x, y, Z, first Z = nr of layers, second Z = laytyp. -frictFile = roughness_M-0p023.ini;roughness_W-0p003.ini # Location of the files with roughness data for 1D. -crossDefFile = crsdef.ini # Cross section definitions for all cross section shapes. -crossLocFile = crsloc.ini # Location definitions of the cross sections on a 1D network. -storageNodeFile = nodeFile.ini # File containing the specification of storage nodes and/or manholes to add extra storage to 1D models. -1d2dLinkFile = # File containing the custom parameterization of 1D-2D links. -profLocFile = # <*_proflocation.xyz>) x, y, z, z = profile refnumber. -profDefFile = # <*_profdefinition.def>) definition for all profile nrs. -profDefXyzFile = # <*_profdefinition.def>) definition for all profile nrs. -manholeFile = # File containing manholes (e.g. <*.dat>). -partitionFile = # <*_part.pol>, polyline(s) x, y. +netFile = fm_net.nc # The net file <*_net.nc> +bathymetryFile = # Removed since March 2022. See [geometry] keyword BedLevelFile. +dryPointsFile = # Dry points file <*.xyz>, third column dummy z values, or polygon file <*.pol>. +structureFile = structures.ini # File <*.ini> containing list of hydraulic structures. +iniFieldFile = fieldFile.ini # Initial and parameter field file <*.ini>. +waterLevIniFile = # Initial water levels sample file <*.xyz>. +landBoundaryFile = # Only for plotting. +thinDamFile = # <*_thd.pli>, Polyline(s) for tracing thin dams. +fixedWeirFile = # <*_fxw.pliz>, Polyline(s) x, y, z, z = fixed weir top levels (formerly fixed weir). +pillarFile = # <*_pillar.pliz>, Polyline file containing four colums with x, y, diameter and Cd coefficient for bridge pillars. +useCaching = 0 # Use caching for geometrical/network-related items (0: no, 1: yes) (section C.19). +vertPlizFile = # <*_vlay.pliz>), = pliz with x, y, Z, first Z = nr of layers, second Z = laytyp. +frictFile = roughness_Manning_0.023.ini;roughness_WhiteColeBrook_0.003.ini # Location of the files with roughness data for 1D. +crossDefFile = crsdef.ini # Cross section definitions for all cross section shapes. +crossLocFile = crsloc.ini # Location definitions of the cross sections on a 1D network. +storageNodeFile = nodeFile.ini # File containing the specification of storage nodes and/or manholes to add extra storage to 1D models. +1d2dLinkFile = # File containing the custom parameterization of 1D-2D links. +profLocFile = # <*_proflocation.xyz>) x, y, z, z = profile refnumber. +profDefFile = # <*_profdefinition.def>) definition for all profile nrs. +profDefXyzFile = # <*_profdefinition.def>) definition for all profile nrs. +manholeFile = # File containing manholes (e.g. <*.dat>). +partitionFile = # <*_part.pol>, polyline(s) x, y. uniformWidth1D = 2.0 -dxWuiMin2D = 0.0 # Smallest fraction dx/wu , set dx > Dxwuimin2D*wu -waterLevIni = 0.0 # Initial water level. -bedLevUni = -5.0 # Uniform bed level [m], (only if bedlevtype>=3), used at missing z values in netfile. -bedSlope = 0.0 # Bed slope inclination, sets zk = bedlevuni + x*bedslope ans sets zbndz = xbndz*bedslope. -bedLevType = 3 # 1: at cell center (tiles xz,yz,bl,bob=max(bl)), 2: at face (tiles xu,yu,blu,bob=blu), 3: at face (using mean node values), 4: at face (using min node values), 5: at face (using max node values), 6: with bl based on node values. -blMeanBelow = -999.0 # if not -999d0, below this level [m] the cell centre bedlevel is the mean of surrouding netnodes. -blMinAbove = -999.0 # if not -999d0, above this level [m] the cell centre bedlevel is the min of surrouding netnodes. -angLat = 0.0 # Angle of latitude S-N [deg], 0=no Coriolis. -angLon = 0.0 # Angle of longitude E-W [deg], 0=Greenwich Mean Time. -conveyance2D = -1 # -1:R=HU, 0:R=H, 1:R=A/P, 2:K=analytic-1D conv, 3:K=analytic-2D conv. -nonlin1D = 1 # Non-linear 1D volumes, applicable for models with closed cross sections. 1=treat closed sections as partially open by using a Preissmann slot, 2=Nested Newton approach, 3=Partial Nested Newton approach. -nonlin2D = 0 # Non-linear 2D volumes, only i.c.m. ibedlevtype = 3 and Conveyance2D>=1. -sillHeightMin = 0.0 # Fixed weir only active if both ground heights are larger than this value [m]. -makeOrthoCenters = 0 # (1: yes, 0: no) switch from circumcentres to orthocentres in geominit. -dCenterInside = 1.0 # limit cell center; 1.0:in cell <-> 0.0:on c/g. -baMin = 1e-06 # Minimum grid cell area [m2], i.c.m. cutcells. -openBoundaryTolerance = 3.0 # Search tolerance factor between boundary polyline and grid cells. [Unit: in cell size units (i.e., not meters)]. -renumberFlowNodes = 1 # Renumber the flow nodes (1: yes, 0: no). -kmx = 0 # Number of vertical layers. -layerType = 1 # Number of vertical layers. -numTopSig = 0 # Number of sigma-layers on top of z-layers. -numTopSigUniform = 1 # Spatially constant number of sigma layers above z-layers in a z-sigma model (1: yes, 0: no, spatially varying) -sigmaGrowthFactor = 1.0 # layer thickness growth factor from bed up. -dzTop = # Z-layer thickness of layers above level Dztopuniabovez -floorLevTopLay = # Floor level of top layer -dzTopUniAboveZ = # Above this level layers will have uniform dzTop, below we use sigmaGrowthFactor -keepZLayeringAtBed = 2 # 0:possibly very thin layer at bed, 1:bedlayerthickness == zlayerthickness, 2=equal thickness first two layers -dxDoubleAt1DEndNodes = 1 # Whether a 1D grid cell at the end of a network has to be extended with 0.5Δx. -changeVelocityAtStructures = 0 # Ignore structure dimensions for the velocity at hydraulic structures, when calculating the surrounding cell centered flow velocities. -changeStructureDimensions = 1 # Change the structure dimensions in case these are inconsistent with the channel dimensions. +dxWuiMin2D = 0.0 # Smallest fraction dx/wu , set dx > Dxwuimin2D*wu +waterLevIni = 0.0 # Initial water level. +bedLevUni = -5.0 # Uniform bed level [m], (only if bedlevtype>=3), used at missing z values in netfile. +bedSlope = 0.0 # Bed slope inclination, sets zk = bedlevuni + x*bedslope ans sets zbndz = xbndz*bedslope. +bedLevType = 3 # 1: at cell center (tiles xz,yz,bl,bob=max(bl)), 2: at face (tiles xu,yu,blu,bob=blu), 3: at face (using mean node values), 4: at face (using min node values), 5: at face (using max node values), 6: with bl based on node values. +blMeanBelow = -999.0 # if not -999d0, below this level [m] the cell centre bedlevel is the mean of surrouding netnodes. +blMinAbove = -999.0 # if not -999d0, above this level [m] the cell centre bedlevel is the min of surrouding netnodes. +angLat = 0.0 # Angle of latitude S-N [deg], 0=no Coriolis. +angLon = 0.0 # Angle of longitude E-W [deg], 0=Greenwich Mean Time. +conveyance2D = -1 # -1:R=HU, 0:R=H, 1:R=A/P, 2:K=analytic-1D conv, 3:K=analytic-2D conv. +nonlin1D = 1 # Non-linear 1D volumes, applicable for models with closed cross sections. 1=treat closed sections as partially open by using a Preissmann slot, 2=Nested Newton approach, 3=Partial Nested Newton approach. +nonlin2D = 0 # Non-linear 2D volumes, only i.c.m. ibedlevtype = 3 and Conveyance2D>=1. +sillHeightMin = 0.0 # Fixed weir only active if both ground heights are larger than this value [m]. +makeOrthoCenters = 0 # (1: yes, 0: no) switch from circumcentres to orthocentres in geominit. +dCenterInside = 1.0 # limit cell center; 1.0:in cell <-> 0.0:on c/g. +baMin = 1e-06 # Minimum grid cell area [m2], i.c.m. cutcells. +openBoundaryTolerance = 3.0 # Search tolerance factor between boundary polyline and grid cells. [Unit: in cell size units (i.e., not meters)]. +renumberFlowNodes = 1 # Renumber the flow nodes (1: yes, 0: no). +kmx = 0 # Number of vertical layers. +layerType = 1 # Number of vertical layers. +numTopSig = 0 # Number of sigma-layers on top of z-layers. +numTopSigUniform = 1 # Spatially constant number of sigma layers above z-layers in a z-sigma model (1: yes, 0: no, spatially varying) +sigmaGrowthFactor = 1.0 # layer thickness growth factor from bed up. +dzTop = # Z-layer thickness of layers above level Dztopuniabovez +floorLevTopLay = # Floor level of top layer +dzTopUniAboveZ = # Above this level layers will have uniform dzTop, below we use sigmaGrowthFactor +keepZLayeringAtBed = 2 # 0:possibly very thin layer at bed, 1:bedlayerthickness == zlayerthickness, 2=equal thickness first two layers +dxDoubleAt1DEndNodes = 1 # Whether a 1D grid cell at the end of a network has to be extended with 0.5Δx. +changeVelocityAtStructures = 0 # Ignore structure dimensions for the velocity at hydraulic structures, when calculating the surrounding cell centered flow velocities. +changeStructureDimensions = 1 # Change the structure dimensions in case these are inconsistent with the channel dimensions. [VolumeTables] useVolumeTables = 0 # Use volume tables for 1D grid cells (1: yes, 0 = no). diff --git a/examples/dflowfm_local/dflowfm/bnd.ext b/examples/dflowfm_local/dflowfm/bnd.ext index 6bcb1413..0eb6705c 100644 --- a/examples/dflowfm_local/dflowfm/bnd.ext +++ b/examples/dflowfm_local/dflowfm/bnd.ext @@ -7,12 +7,12 @@ fileType = extForce [Boundary] quantity = waterlevelbnd nodeId = 664197.234160_1527152.705985 -forcingFile = boundaryconditions1d_waterlevelbnd.bc +forcingFile = boundarycondition1d.bc [Boundary] quantity = waterlevelbnd nodeId = 666180.040000_1525894.770000 -forcingFile = boundaryconditions1d_waterlevelbnd.bc +forcingFile = boundarycondition1d.bc [Boundary] quantity = waterlevelbnd @@ -30,7 +30,7 @@ name = lateral1d_points_0 locationType = 1d branchId = branch_7 chainage = 370.839 -discharge = lateral1d_discharge.bc +discharge = lateral1d.bc [Lateral] id = lateral1d_polygons_0 @@ -39,7 +39,7 @@ locationType = 1d numCoordinates = 5 xCoordinates = 663197.4913821429 663634.2637682621 662898.6471179562 662500.1880990406 663197.4913821429 yCoordinates = 1525273.2984456269 1524966.7915079996 1524208.1868373717 1524867.1767532704 1525273.2984456269 -discharge = lateral1d_discharge.bc +discharge = lateral1d.bc [Meteo] quantity = rainfall_rate # Name of the quantity. See UM Section C.5.3 diff --git a/examples/dflowfm_local/dflowfm/fm_net.nc b/examples/dflowfm_local/dflowfm/fm_net.nc index b52b6be76eb2be4a7b3e1b5a1793273d3048c1f1..87c04e857d6e166ce321a3e4fa5384a212898453 100644 GIT binary patch delta 34 pcmbQUoO8}{&JD^;+(w29hK5!~##Tl~&3a7jdQ6Pl^_ZCQ0s*P62(ADC delta 34 ocmbQUoO8}{&JD^;+=iwKhDKHfmO#|3$JDOJ#JF9Li777-0IG}#y8r+H diff --git a/examples/dflowfm_local/dimr_config.xml b/examples/dflowfm_local/dimr_config.xml index eea0ab4e..09845f2e 100644 --- a/examples/dflowfm_local/dimr_config.xml +++ b/examples/dflowfm_local/dimr_config.xml @@ -3,7 +3,7 @@ 1.3 hydrolib-core 0.5.2 - 2023-09-15T10:09:00.249442 + 2023-09-21T09:22:59.483463 diff --git a/examples/dflowfm_local/geoms/boundaries.geojson b/examples/dflowfm_local/geoms/boundaries.geojson index 67965256..931af5aa 100644 --- a/examples/dflowfm_local/geoms/boundaries.geojson +++ b/examples/dflowfm_local/geoms/boundaries.geojson @@ -2,17 +2,17 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -{ "type": "Feature", "properties": { "level_0": 662793.79418679164, "level_1": 1524515.4517321615, "branchtype": "river", "branchid": "river_1", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_1", "frictionid": "Manning_0.023", "diameter": null, "index_right": 1, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "where": "downstream", "distance_right": 2.6354886210617495e-07, "nodeid": "662793.794187_1524515.451732" }, "geometry": { "type": "Point", "coordinates": [ 662793.794186791637912, 1524515.451732161454856 ] } }, -{ "type": "Feature", "properties": { "level_0": 664197.23415962339, "level_1": 1527152.7059848213, "branchtype": "river", "branchid": "river_2", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_2", "frictionid": "Manning_0.023", "diameter": null, "index_right": 2, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "where": "downstream", "distance_right": 4.1679906021887385e-07, "nodeid": "664197.234160_1527152.705985" }, "geometry": { "type": "Point", "coordinates": [ 664197.234159623389132, 1527152.705984821310267 ] } }, -{ "type": "Feature", "properties": { "level_0": 666180.04, "level_1": 1525894.77, "branchtype": "river", "branchid": "branch_8", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_8", "frictionid": "Manning_0.023", "diameter": null, "index_right": 10, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "where": "upstream", "distance_right": 6.9849193096160889e-10, "nodeid": "666180.040000_1525894.770000" }, "geometry": { "type": "Point", "coordinates": [ 666180.040000000037253, 1525894.769999999320135 ] } }, -{ "type": "Feature", "properties": { "level_0": 664789.14617260336, "level_1": 1525073.3461271923, "branchtype": "river", "branchid": "branch_11", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_11", "frictionid": "Manning_0.023", "diameter": null, "index_right": 12, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "where": "upstream", "distance_right": 4.4079386833570057e-07, "nodeid": "664789.146173_1525073.346127" }, "geometry": { "type": "Point", "coordinates": [ 664789.146172603359446, 1525073.346127192256972 ] } }, -{ "type": "Feature", "properties": { "level_0": 664190.38579999981, "level_1": 1525924.0326000003, "branchtype": "pipe", "branchid": "pipe_5", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_5", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 16, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 3.2927225399135965e-10, "nodeid": "664190.385800_1525924.032600" }, "geometry": { "type": "Point", "coordinates": [ 664190.385799999814481, 1525924.032600000267848 ] } }, -{ "type": "Feature", "properties": { "level_0": 664048.32531966059, "level_1": 1525098.0711124309, "branchtype": "pipe", "branchid": "pipe_9", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 20, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 5.4853769327396927e-07, "nodeid": "664048.325320_1525098.071112" }, "geometry": { "type": "Point", "coordinates": [ 664048.325319660594687, 1525098.071112430887297 ] } }, -{ "type": "Feature", "properties": { "level_0": 664702.72692603013, "level_1": 1525750.0985501537, "branchtype": "pipe", "branchid": "pipe_10", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 21, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 1.5659834095829541e-07, "nodeid": "664702.726926_1525750.098550" }, "geometry": { "type": "Point", "coordinates": [ 664702.726926030125469, 1525750.098550153663382 ] } }, -{ "type": "Feature", "properties": { "level_0": 664747.43349663052, "level_1": 1525729.6497995616, "branchtype": "pipe", "branchid": "pipe_12", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 23, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 5.7336208882836857e-07, "nodeid": "664747.433497_1525729.649800" }, "geometry": { "type": "Point", "coordinates": [ 664747.433496630517766, 1525729.649799561593682 ] } }, -{ "type": "Feature", "properties": { "level_0": 665219.64311349345, "level_1": 1525514.959856804, "branchtype": "pipe", "branchid": "pipe_14", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_14", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 25, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 5.3099907323260637e-07, "nodeid": "665219.643113_1525514.959857" }, "geometry": { "type": "Point", "coordinates": [ 665219.643113493453711, 1525514.959856803994626 ] } }, -{ "type": "Feature", "properties": { "level_0": 664708.73862075247, "level_1": 1524483.1447981687, "branchtype": "pipe", "branchid": "pipe_15", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_15", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 26, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 2.9945179934390397e-07, "nodeid": "664708.738621_1524483.144798" }, "geometry": { "type": "Point", "coordinates": [ 664708.738620752468705, 1524483.144798168679699 ] } }, -{ "type": "Feature", "properties": { "level_0": 665277.57411764679, "level_1": 1525446.3931947846, "branchtype": "pipe", "branchid": "pipe_16", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_16", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 27, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 4.136866578190493e-07, "nodeid": "665277.574118_1525446.393195" }, "geometry": { "type": "Point", "coordinates": [ 665277.574117646785453, 1525446.393194784643129 ] } }, -{ "type": "Feature", "properties": { "level_0": 665292.61532070651, "level_1": 1525470.8495163794, "branchtype": "pipe", "branchid": "pipe_17", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_17", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 28, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 4.7975319107342047e-07, "nodeid": "665292.615321_1525470.849516" }, "geometry": { "type": "Point", "coordinates": [ 665292.615320706507191, 1525470.849516379414126 ] } } +{ "type": "Feature", "properties": { "level_0": 662793.79418679164, "level_1": 1524515.4517321615, "branchid": "river_1", "branchtype": "river", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_1", "frictionid": "Manning_0.023", "diameter": null, "index_right": 1, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "where": "downstream", "distance_right": 2.6354886210617495e-07, "nodeid": "662793.794187_1524515.451732" }, "geometry": { "type": "Point", "coordinates": [ 662793.794186791637912, 1524515.451732161454856 ] } }, +{ "type": "Feature", "properties": { "level_0": 664197.23415962339, "level_1": 1527152.7059848213, "branchid": "river_2", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_2", "frictionid": "Manning_0.023", "diameter": null, "index_right": 2, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "where": "downstream", "distance_right": 4.1679906021887385e-07, "nodeid": "664197.234160_1527152.705985" }, "geometry": { "type": "Point", "coordinates": [ 664197.234159623389132, 1527152.705984821310267 ] } }, +{ "type": "Feature", "properties": { "level_0": 666180.04, "level_1": 1525894.77, "branchid": "branch_8", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_8", "frictionid": "Manning_0.023", "diameter": null, "index_right": 10, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "where": "upstream", "distance_right": 6.9849193096160889e-10, "nodeid": "666180.040000_1525894.770000" }, "geometry": { "type": "Point", "coordinates": [ 666180.040000000037253, 1525894.769999999320135 ] } }, +{ "type": "Feature", "properties": { "level_0": 664789.14617260336, "level_1": 1525073.3461271923, "branchid": "branch_11", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_11", "frictionid": "Manning_0.023", "diameter": null, "index_right": 12, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "where": "upstream", "distance_right": 4.4079386833570057e-07, "nodeid": "664789.146173_1525073.346127" }, "geometry": { "type": "Point", "coordinates": [ 664789.146172603359446, 1525073.346127192256972 ] } }, +{ "type": "Feature", "properties": { "level_0": 664190.38579999981, "level_1": 1525924.0326000003, "branchid": "pipe_5", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_5", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 16, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 3.2927225399135965e-10, "nodeid": "664190.385800_1525924.032600" }, "geometry": { "type": "Point", "coordinates": [ 664190.385799999814481, 1525924.032600000267848 ] } }, +{ "type": "Feature", "properties": { "level_0": 664048.32531966059, "level_1": 1525098.0711124309, "branchid": "pipe_9", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 20, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 5.4853769327396927e-07, "nodeid": "664048.325320_1525098.071112" }, "geometry": { "type": "Point", "coordinates": [ 664048.325319660594687, 1525098.071112430887297 ] } }, +{ "type": "Feature", "properties": { "level_0": 664702.72692603013, "level_1": 1525750.0985501537, "branchid": "pipe_10", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 21, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 1.5659834095829541e-07, "nodeid": "664702.726926_1525750.098550" }, "geometry": { "type": "Point", "coordinates": [ 664702.726926030125469, 1525750.098550153663382 ] } }, +{ "type": "Feature", "properties": { "level_0": 664747.43349663052, "level_1": 1525729.6497995616, "branchid": "pipe_12", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 23, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 5.7336208882836857e-07, "nodeid": "664747.433497_1525729.649800" }, "geometry": { "type": "Point", "coordinates": [ 664747.433496630517766, 1525729.649799561593682 ] } }, +{ "type": "Feature", "properties": { "level_0": 665219.64311349345, "level_1": 1525514.959856804, "branchid": "pipe_14", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_14", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 25, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 5.3099907323260637e-07, "nodeid": "665219.643113_1525514.959857" }, "geometry": { "type": "Point", "coordinates": [ 665219.643113493453711, 1525514.959856803994626 ] } }, +{ "type": "Feature", "properties": { "level_0": 664708.73862075247, "level_1": 1524483.1447981687, "branchid": "pipe_15", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_15", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 26, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 2.9945179934390397e-07, "nodeid": "664708.738621_1524483.144798" }, "geometry": { "type": "Point", "coordinates": [ 664708.738620752468705, 1524483.144798168679699 ] } }, +{ "type": "Feature", "properties": { "level_0": 665277.57411764679, "level_1": 1525446.3931947846, "branchid": "pipe_16", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_16", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 27, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 4.136866578190493e-07, "nodeid": "665277.574118_1525446.393195" }, "geometry": { "type": "Point", "coordinates": [ 665277.574117646785453, 1525446.393194784643129 ] } }, +{ "type": "Feature", "properties": { "level_0": 665292.61532070651, "level_1": 1525470.8495163794, "branchid": "pipe_17", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_17", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 28, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 4.7975319107342047e-07, "nodeid": "665292.615321_1525470.849516" }, "geometry": { "type": "Point", "coordinates": [ 665292.615320706507191, 1525470.849516379414126 ] } } ] } diff --git a/examples/dflowfm_local/geoms/branches.geojson b/examples/dflowfm_local/geoms/branches.geojson index 9c509b9c..d401d93b 100644 --- a/examples/dflowfm_local/geoms/branches.geojson +++ b/examples/dflowfm_local/geoms/branches.geojson @@ -2,33 +2,33 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_4", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_4", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_0_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664438.813829420600086, 1525829.800284768920392 ], [ 664429.038999999989755, 1526107.098 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_5", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_5", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_1_generated", "manhole_dn": "manhole_0_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664190.385799999814481, 1525924.032600000267848 ], [ 664438.813829420600086, 1525829.800284768920392 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_6", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_2_generated", "manhole_dn": "manhole_0_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664217.490140905487351, 1525583.23970616585575 ], [ 664438.813829420600086, 1525829.800284768920392 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_7", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_3_generated", "manhole_dn": "manhole_2_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 663936.864700614358298, 1525261.152571672573686 ], [ 664217.490140905487351, 1525583.23970616585575 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_8", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_4_generated", "manhole_dn": "manhole_3_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 663871.550461587961763, 1525175.738024139311165 ], [ 663897.086400000494905, 1525212.559499999275431 ], [ 663936.864700614358298, 1525261.152571672573686 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_9", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_5_generated", "manhole_dn": "manhole_4_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664048.325319660594687, 1525098.071112430887297 ], [ 663871.550461587961763, 1525175.738024139311165 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_10", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_6_generated", "manhole_dn": "manhole_7_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664702.726926030125469, 1525750.098550153663382 ], [ 664481.894200000097044, 1525830.303300000727177 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_11", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_7_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664481.894200000097044, 1525830.303300000727177 ], [ 664474.13, 1526115.7 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_12", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_8_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664747.433496630517766, 1525729.649799561593682 ], [ 664838.810497992672026, 1525698.612855288665742 ], [ 664907.926478271954693, 1525663.288345249835402 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_13", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_13", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_9_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664849.475700000301003, 1525031.354499999433756 ], [ 665115.699999999953434, 1524944.79 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_14", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_14", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_10_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665219.643113493453711, 1525514.959856803994626 ], [ 665030.18360000057146, 1525603.506899999454618 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_15", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_15", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_11_generated", "manhole_dn": "manhole_9_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664708.738620752468705, 1524483.144798168679699 ], [ 664849.475700000301003, 1525031.354499999433756 ], [ 664849.475700000301003, 1525031.354499999433756 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_16", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_16", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_12_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665277.574117646785453, 1525446.393194784643129 ], [ 665356.868200000026263, 1525406.9835 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_17", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_17", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_13_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665292.615320706507191, 1525470.849516379414126 ], [ 665369.906399999978021, 1525431.4412 ], [ 665369.906399999978021, 1525431.4412 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "river_1", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_1", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664057.966296999948099, 1526147.834882 ], [ 663918.391924358904362, 1525803.10090322420001 ], [ 663700.482064640615135, 1525466.331120023271069 ], [ 663353.045365229598247, 1525088.417517154943198 ], [ 662879.129516471526586, 1524643.454726681346074 ], [ 662793.794186791637912, 1524515.451732161454856 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "river_2", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_2", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664057.966296999948099, 1526147.834882 ], [ 664218.310854589915834, 1526625.788610660471022 ], [ 664218.310854589915834, 1527005.169120056321844 ], [ 664197.234159623389132, 1527152.705984821310267 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_1", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_1", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665115.699999999953434, 1524944.79 ], [ 665356.868200000026263, 1525406.9835 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_2", "branchorder": 2.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_2", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665356.868200000026263, 1525406.9835 ], [ 665369.906399999978021, 1525431.441199999069795 ], [ 665369.906399999978021, 1525431.4412 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_3", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_3", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665369.906399999978021, 1525431.4412 ], [ 665641.789999999804422, 1525937.96000000089407 ], [ 665641.789999999804422, 1525937.96000000089407 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_4", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_4", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665641.789999999804422, 1525937.96000000089407 ], [ 665560.620547444559634, 1525952.124135404126719 ], [ 665480.575254552299157, 1525953.687039414886385 ], [ 665416.820000000414439, 1525962.189999999245629 ], [ 665346.659376955241896, 1525982.895817694021389 ], [ 665271.309999999706633, 1526001.859999999403954 ], [ 665243.630000000470318, 1526003.289999998640269 ], [ 665243.630000000470318, 1526003.289999997941777 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_5", "branchorder": 3.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_5", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665243.630000000470318, 1526003.289999997941777 ], [ 665116.950000000419095, 1525983.029999999096617 ], [ 665051.90000000083819, 1525977.32 ], [ 664963.504724813159555, 1526014.666760261869058 ], [ 664918.370000000344589, 1526039.810000000521541 ], [ 664826.210000000428408, 1526041.519999999552965 ], [ 664752.459499345044605, 1526065.157490010838956 ], [ 664672.28994727297686, 1526086.417805780190974 ], [ 664642.852168873418123, 1526095.560649296734482 ], [ 664550.869999999529682, 1526115.410000000149012 ], [ 664474.13, 1526115.7 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_6", "branchorder": 4.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_6", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664474.13, 1526115.7 ], [ 664429.038999999989755, 1526107.098 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_7", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_7", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664429.038999999989755, 1526107.098 ], [ 664272.40999999945052, 1526129.970000000204891 ], [ 664169.979999999864958, 1526140.529999999562278 ], [ 664092.240000000223517, 1526143.2899999988731 ], [ 664057.966296999948099, 1526147.834882 ], [ 664057.966296999948099, 1526147.834882 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_8", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_8", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 666180.040000000037253, 1525894.769999999320135 ], [ 665891.336423385655507, 1526041.311705864733085 ], [ 665733.269999999320135, 1526117.310000000521541 ], [ 665733.269999999320135, 1526117.310000000521541 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_10", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_10", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665733.269999999320135, 1526117.310000000521541 ], [ 665641.789999999804422, 1525937.96000000089407 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_11", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_11", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664789.146172603359446, 1525073.346127192256972 ], [ 665015.157200000365265, 1525576.51439999951981 ], [ 665015.157200000365265, 1525576.514399999286979 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_12", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_12", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665015.157200000365265, 1525576.514399999286979 ], [ 665030.18360000057146, 1525603.506899999454618 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_13", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_13", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665030.18360000057146, 1525603.506899999454618 ], [ 665243.630000000470318, 1526003.289999997941777 ] ] } } +{ "type": "Feature", "properties": { "branchid": "pipe_4", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_4", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_0_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664438.813829420600086, 1525829.800284768920392 ], [ 664429.038999999989755, 1526107.098 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_5", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_5", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_1_generated", "manhole_dn": "manhole_0_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664190.385799999814481, 1525924.032600000267848 ], [ 664438.813829420600086, 1525829.800284768920392 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_6", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_2_generated", "manhole_dn": "manhole_0_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664217.490140905487351, 1525583.23970616585575 ], [ 664438.813829420600086, 1525829.800284768920392 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_7", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_3_generated", "manhole_dn": "manhole_2_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 663936.864700614358298, 1525261.152571672573686 ], [ 664217.490140905487351, 1525583.23970616585575 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_8", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_4_generated", "manhole_dn": "manhole_3_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 663871.550461587961763, 1525175.738024139311165 ], [ 663897.086400000494905, 1525212.559499999275431 ], [ 663936.864700614358298, 1525261.152571672573686 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_9", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_5_generated", "manhole_dn": "manhole_4_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664048.325319660594687, 1525098.071112430887297 ], [ 663871.550461587961763, 1525175.738024139311165 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_10", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_6_generated", "manhole_dn": "manhole_7_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664702.726926030125469, 1525750.098550153663382 ], [ 664481.894200000097044, 1525830.303300000727177 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_11", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_7_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664481.894200000097044, 1525830.303300000727177 ], [ 664474.13, 1526115.7 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_12", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_8_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664747.433496630517766, 1525729.649799561593682 ], [ 664838.810497992672026, 1525698.612855288665742 ], [ 664907.926478271954693, 1525663.288345249835402 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_13", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_13", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_9_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664849.475700000301003, 1525031.354499999433756 ], [ 665115.699999999953434, 1524944.79 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_14", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_14", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_10_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665219.643113493453711, 1525514.959856803994626 ], [ 665030.18360000057146, 1525603.506899999454618 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_15", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_15", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_11_generated", "manhole_dn": "manhole_9_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664708.738620752468705, 1524483.144798168679699 ], [ 664849.475700000301003, 1525031.354499999433756 ], [ 664849.475700000301003, 1525031.354499999433756 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_16", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_16", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_12_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665277.574117646785453, 1525446.393194784643129 ], [ 665356.868200000026263, 1525406.9835 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_17", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_17", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_13_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665292.615320706507191, 1525470.849516379414126 ], [ 665369.906399999978021, 1525431.4412 ], [ 665369.906399999978021, 1525431.4412 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "river_1", "branchtype": "river", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_1", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664057.966296999948099, 1526147.834882 ], [ 663918.391924358904362, 1525803.10090322420001 ], [ 663700.482064640615135, 1525466.331120023271069 ], [ 663353.045365229598247, 1525088.417517154943198 ], [ 662879.129516471526586, 1524643.454726681346074 ], [ 662793.794186791637912, 1524515.451732161454856 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "river_2", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_2", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664057.966296999948099, 1526147.834882 ], [ 664218.310854589915834, 1526625.788610660471022 ], [ 664218.310854589915834, 1527005.169120056321844 ], [ 664197.234159623389132, 1527152.705984821310267 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_1", "branchtype": "river", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_1", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665115.699999999953434, 1524944.79 ], [ 665356.868200000026263, 1525406.9835 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_2", "branchtype": "river", "branchorder": 2.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_2", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665356.868200000026263, 1525406.9835 ], [ 665369.906399999978021, 1525431.441199999069795 ], [ 665369.906399999978021, 1525431.4412 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_3", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_3", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665369.906399999978021, 1525431.4412 ], [ 665641.789999999804422, 1525937.96000000089407 ], [ 665641.789999999804422, 1525937.96000000089407 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_4", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_4", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665641.789999999804422, 1525937.96000000089407 ], [ 665560.620547444559634, 1525952.124135404126719 ], [ 665480.575254552299157, 1525953.687039414886385 ], [ 665416.820000000414439, 1525962.189999999245629 ], [ 665346.659376955241896, 1525982.895817694021389 ], [ 665271.309999999706633, 1526001.859999999403954 ], [ 665243.630000000470318, 1526003.289999998640269 ], [ 665243.630000000470318, 1526003.289999997941777 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_5", "branchtype": "river", "branchorder": 3.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_5", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665243.630000000470318, 1526003.289999997941777 ], [ 665116.950000000419095, 1525983.029999999096617 ], [ 665051.90000000083819, 1525977.32 ], [ 664963.504724813159555, 1526014.666760261869058 ], [ 664918.370000000344589, 1526039.810000000521541 ], [ 664826.210000000428408, 1526041.519999999552965 ], [ 664752.459499345044605, 1526065.157490010838956 ], [ 664672.28994727297686, 1526086.417805780190974 ], [ 664642.852168873418123, 1526095.560649296734482 ], [ 664550.869999999529682, 1526115.410000000149012 ], [ 664474.13, 1526115.7 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_6", "branchtype": "river", "branchorder": 4.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_6", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664474.13, 1526115.7 ], [ 664429.038999999989755, 1526107.098 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_7", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_7", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664429.038999999989755, 1526107.098 ], [ 664272.40999999945052, 1526129.970000000204891 ], [ 664169.979999999864958, 1526140.529999999562278 ], [ 664092.240000000223517, 1526143.2899999988731 ], [ 664057.966296999948099, 1526147.834882 ], [ 664057.966296999948099, 1526147.834882 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_8", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_8", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 666180.040000000037253, 1525894.769999999320135 ], [ 665891.336423385655507, 1526041.311705864733085 ], [ 665733.269999999320135, 1526117.310000000521541 ], [ 665733.269999999320135, 1526117.310000000521541 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_10", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_10", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665733.269999999320135, 1526117.310000000521541 ], [ 665641.789999999804422, 1525937.96000000089407 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_11", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_11", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664789.146172603359446, 1525073.346127192256972 ], [ 665015.157200000365265, 1525576.51439999951981 ], [ 665015.157200000365265, 1525576.514399999286979 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_12", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_12", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665015.157200000365265, 1525576.514399999286979 ], [ 665030.18360000057146, 1525603.506899999454618 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_13", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_13", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665030.18360000057146, 1525603.506899999454618 ], [ 665243.630000000470318, 1526003.289999997941777 ] ] } } ] } diff --git a/examples/dflowfm_local/geoms/bridges.geojson b/examples/dflowfm_local/geoms/bridges.geojson index 2ed8bfd8..f5d030f0 100644 --- a/examples/dflowfm_local/geoms/bridges.geojson +++ b/examples/dflowfm_local/geoms/bridges.geojson @@ -2,7 +2,7 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -{ "type": "Feature", "properties": { "outletlosscoeff": 0.2, "inletlosscoeff": 0.2, "pillarwidth": null, "csdefid": "rect_h1.550_w2.000_cno_point", "shift": 2.34, "id": "bridge_1", "frictiontype": "Manning", "formfactor": null, "type": "bridge", "friction": 0.023, "allowedflowdir": "positive", "chainage": 14.101, "branchid": "branch_12", "length": 10.0 }, "geometry": { "type": "Point", "coordinates": [ 665021.849053248995915, 1525588.928306785644963 ] } }, -{ "type": "Feature", "properties": { "outletlosscoeff": 0.82, "inletlosscoeff": 0.8, "pillarwidth": null, "csdefid": "rect_h1.800_w5.000_cyes_point", "shift": 2.37, "id": "bridge_2", "frictiontype": "Manning", "formfactor": null, "type": "bridge", "friction": 0.023, "allowedflowdir": "both", "chainage": 485.794, "branchid": "branch_3", "length": 5.0 }, "geometry": { "type": "Point", "coordinates": [ 665599.689329552114941, 1525859.454655284294859 ] } } +{ "type": "Feature", "properties": { "pillarwidth": null, "branchid": "branch_12", "friction": 0.023, "length": 10.0, "type": "bridge", "frictiontype": "Manning", "formfactor": null, "outletlosscoeff": 0.2, "inletlosscoeff": 0.2, "id": "bridge_1", "shift": 2.34, "chainage": 14.101, "csdefid": "rect_h1.550_w2.000_cno_point", "allowedflowdir": "positive" }, "geometry": { "type": "Point", "coordinates": [ 665021.849053248995915, 1525588.928306785644963 ] } }, +{ "type": "Feature", "properties": { "pillarwidth": null, "branchid": "branch_3", "friction": 0.023, "length": 5.0, "type": "bridge", "frictiontype": "Manning", "formfactor": null, "outletlosscoeff": 0.82, "inletlosscoeff": 0.8, "id": "bridge_2", "shift": 2.37, "chainage": 485.794, "csdefid": "rect_h1.800_w5.000_cyes_point", "allowedflowdir": "both" }, "geometry": { "type": "Point", "coordinates": [ 665599.689329552114941, 1525859.454655284294859 ] } } ] } diff --git a/examples/dflowfm_local/geoms/culverts.geojson b/examples/dflowfm_local/geoms/culverts.geojson index 50c07170..2a2bd46a 100644 --- a/examples/dflowfm_local/geoms/culverts.geojson +++ b/examples/dflowfm_local/geoms/culverts.geojson @@ -2,6 +2,6 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -{ "type": "Feature", "properties": { "rightlevel": 2.5, "leftlevel": 2.56, "bedfrictiontype": "Manning", "bedfriction": 0.012, "csdefid": "rect_h1.500_w1.500_cyes_point", "id": "culvert_1", "numlosscoeff": null, "type": "culvert", "allowedflowdir": "positive", "chainage": 331.832, "valveopeningheight": null, "branchid": "branch_13", "length": 1.0, "outletlosscoeff": 0.2, "inletlosscoeff": 0.2, "valveonoff": 0.0, "losscoeff": null, "relopening": null }, "geometry": { "type": "Point", "coordinates": [ 665186.754018069244921, 1525896.07843215460889 ] } } +{ "type": "Feature", "properties": { "length": 1.0, "valveopeningheight": null, "type": "culvert", "relopening": null, "outletlosscoeff": 0.2, "inletlosscoeff": 0.2, "numlosscoeff": null, "csdefid": "rect_h1.500_w1.500_cyes_point", "allowedflowdir": "positive", "branchid": "branch_13", "leftlevel": 2.56, "rightlevel": 2.5, "bedfrictiontype": "Manning", "valveonoff": 0.0, "id": "culvert_1", "chainage": 331.832, "bedfriction": 0.012, "losscoeff": null }, "geometry": { "type": "Point", "coordinates": [ 665186.754018069244921, 1525896.07843215460889 ] } } ] } diff --git a/examples/dflowfm_local/geoms/manholes.geojson b/examples/dflowfm_local/geoms/manholes.geojson index 7a683068..1a835e0b 100644 --- a/examples/dflowfm_local/geoms/manholes.geojson +++ b/examples/dflowfm_local/geoms/manholes.geojson @@ -2,19 +2,19 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -{ "type": "Feature", "properties": { "_index": 14, "bedlevel": -3.0, "branchid": "pipe_4;pipe_5;pipe_6", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_2", "shape": null, "area": 1.0, "streetlevel": 8.03125, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 4.7985182629097901e-07, "index_right": 15, "_streetlevel_dem": 8.03125, "nodeid": "664438.813829_1525829.800285", "id": "664438.813829_1525829.800285", "name": "MH_2", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664438.813829420600086, 1525829.800284768920392 ] } }, -{ "type": "Feature", "properties": { "_index": 15, "bedlevel": -3.0, "branchid": "pipe_5", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_1", "shape": null, "area": 1.0, "streetlevel": 4.9921875, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 3.2927225399135965e-10, "index_right": 16, "_streetlevel_dem": 4.9921875, "nodeid": "664190.385800_1525924.032600", "id": "664190.385800_1525924.032600", "name": "MH_1", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664190.385799999814481, 1525924.032600000267848 ] } }, -{ "type": "Feature", "properties": { "_index": 16, "bedlevel": -3.0, "branchid": "pipe_6;pipe_7", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_4", "shape": null, "area": 1.0, "streetlevel": 6.5546875, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 1.9083308615545579e-07, "index_right": 17, "_streetlevel_dem": 6.5546875, "nodeid": "664217.490141_1525583.239706", "id": "664217.490141_1525583.239706", "name": "MH_4", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664217.490140905487351, 1525583.23970616585575 ] } }, -{ "type": "Feature", "properties": { "_index": 17, "bedlevel": -3.0, "branchid": "pipe_7;pipe_8", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_5", "shape": null, "area": 1.0, "streetlevel": 5.7421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 5.0588201413871898e-07, "index_right": 18, "_streetlevel_dem": 5.7421875, "nodeid": "663936.864701_1525261.152572", "id": "663936.864701_1525261.152572", "name": "MH_5", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 663936.864700614358298, 1525261.152571672573686 ] } }, -{ "type": "Feature", "properties": { "_index": 18, "bedlevel": -3.0, "branchid": "pipe_8;pipe_9", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_6", "shape": null, "area": 1.0, "streetlevel": 7.640625, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 4.348846544242845e-07, "index_right": 19, "_streetlevel_dem": 7.640625, "nodeid": "663871.550462_1525175.738024", "id": "663871.550462_1525175.738024", "name": "MH_6", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 663871.550461587961763, 1525175.738024139311165 ] } }, -{ "type": "Feature", "properties": { "_index": 19, "bedlevel": -3.0, "branchid": "pipe_9", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_7", "shape": null, "area": 1.0, "streetlevel": 6.2421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 5.4853769327396927e-07, "index_right": 20, "_streetlevel_dem": 6.2421875, "nodeid": "664048.325320_1525098.071112", "id": "664048.325320_1525098.071112", "name": "MH_7", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664048.325319660594687, 1525098.071112430887297 ] } }, -{ "type": "Feature", "properties": { "_index": 20, "bedlevel": -3.0, "branchid": "pipe_10", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_9", "shape": null, "area": 1.0, "streetlevel": 6.78125, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 1.5659834095829541e-07, "index_right": 21, "_streetlevel_dem": 6.78125, "nodeid": "664702.726926_1525750.098550", "id": "664702.726926_1525750.098550", "name": "MH_9", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664702.726926030125469, 1525750.098550153663382 ] } }, -{ "type": "Feature", "properties": { "_index": 20, "bedlevel": -3.0, "branchid": "pipe_10;pipe_11", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_8", "shape": null, "area": 1.0, "streetlevel": 7.8125, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 7.0812675756148753e-10, "index_right": 22, "_streetlevel_dem": 7.8125, "nodeid": "664481.894200_1525830.303300", "id": "664481.894200_1525830.303300", "name": "MH_8", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664481.894200000097044, 1525830.303300000727177 ] } }, -{ "type": "Feature", "properties": { "_index": 22, "bedlevel": -3.0, "branchid": "pipe_12", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_10", "shape": null, "area": 1.0, "streetlevel": 6.6328125, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 5.7336208882836857e-07, "index_right": 23, "_streetlevel_dem": 6.6328125, "nodeid": "664747.433497_1525729.649800", "id": "664747.433497_1525729.649800", "name": "MH_10", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664747.433496630517766, 1525729.649799561593682 ] } }, -{ "type": "Feature", "properties": { "_index": 23, "bedlevel": -3.0, "branchid": "pipe_13;pipe_15", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_15", "shape": null, "area": 1.0, "streetlevel": 7.3203125, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 5.8207660913467407e-10, "index_right": 24, "_streetlevel_dem": 7.3203125, "nodeid": "664849.475700_1525031.354500", "id": "664849.475700_1525031.354500", "name": "MH_15", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664849.475700000301003, 1525031.354499999433756 ] } }, -{ "type": "Feature", "properties": { "_index": 24, "bedlevel": -3.0, "branchid": "pipe_14", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_11", "shape": null, "area": 1.0, "streetlevel": 6.5625, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 5.3099907323260637e-07, "index_right": 25, "_streetlevel_dem": 6.5625, "nodeid": "665219.643113_1525514.959857", "id": "665219.643113_1525514.959857", "name": "MH_11", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 665219.643113493453711, 1525514.959856803994626 ] } }, -{ "type": "Feature", "properties": { "_index": 25, "bedlevel": -3.0, "branchid": "pipe_15", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_14", "shape": null, "area": 1.0, "streetlevel": 5.9453125, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 2.9945179934390397e-07, "index_right": 26, "_streetlevel_dem": 5.9453125, "nodeid": "664708.738621_1524483.144798", "id": "664708.738621_1524483.144798", "name": "MH_14", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664708.738620752468705, 1524483.144798168679699 ] } }, -{ "type": "Feature", "properties": { "_index": 26, "bedlevel": -3.0, "branchid": "pipe_16", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_13", "shape": null, "area": 1.0, "streetlevel": 6.34375, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 4.136866578190493e-07, "index_right": 27, "_streetlevel_dem": 6.34375, "nodeid": "665277.574118_1525446.393195", "id": "665277.574118_1525446.393195", "name": "MH_13", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 665277.574117646785453, 1525446.393194784643129 ] } }, -{ "type": "Feature", "properties": { "_index": 27, "bedlevel": -3.0, "branchid": "pipe_17", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "MH_12", "shape": null, "area": 1.0, "streetlevel": 6.34375, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 4.7975319107342047e-07, "index_right": 28, "_streetlevel_dem": 6.34375, "nodeid": "665292.615321_1525470.849516", "id": "665292.615321_1525470.849516", "name": "MH_12", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 665292.615320706507191, 1525470.849516379414126 ] } } +{ "type": "Feature", "properties": { "_index": 14, "bedlevel": -3.0, "branchid": "pipe_4;pipe_5;pipe_6", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_2", "shape": null, "area": 1.0, "streetlevel": 8.03125, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 4.7985182629097901e-07, "index_right": 15, "_streetlevel_dem": 8.03125, "nodeid": "664438.813829_1525829.800285", "id": "664438.813829_1525829.800285", "name": "MH_2", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664438.813829420600086, 1525829.800284768920392 ] } }, +{ "type": "Feature", "properties": { "_index": 15, "bedlevel": -3.0, "branchid": "pipe_5", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_1", "shape": null, "area": 1.0, "streetlevel": 4.9921875, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 3.2927225399135965e-10, "index_right": 16, "_streetlevel_dem": 4.9921875, "nodeid": "664190.385800_1525924.032600", "id": "664190.385800_1525924.032600", "name": "MH_1", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664190.385799999814481, 1525924.032600000267848 ] } }, +{ "type": "Feature", "properties": { "_index": 16, "bedlevel": -3.0, "branchid": "pipe_6;pipe_7", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_4", "shape": null, "area": 1.0, "streetlevel": 6.5546875, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 1.9083308615545579e-07, "index_right": 17, "_streetlevel_dem": 6.5546875, "nodeid": "664217.490141_1525583.239706", "id": "664217.490141_1525583.239706", "name": "MH_4", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664217.490140905487351, 1525583.23970616585575 ] } }, +{ "type": "Feature", "properties": { "_index": 17, "bedlevel": -3.0, "branchid": "pipe_7;pipe_8", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_5", "shape": null, "area": 1.0, "streetlevel": 5.7421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 5.0588201413871898e-07, "index_right": 18, "_streetlevel_dem": 5.7421875, "nodeid": "663936.864701_1525261.152572", "id": "663936.864701_1525261.152572", "name": "MH_5", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 663936.864700614358298, 1525261.152571672573686 ] } }, +{ "type": "Feature", "properties": { "_index": 18, "bedlevel": -3.0, "branchid": "pipe_8;pipe_9", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_6", "shape": null, "area": 1.0, "streetlevel": 7.640625, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 4.348846544242845e-07, "index_right": 19, "_streetlevel_dem": 7.640625, "nodeid": "663871.550462_1525175.738024", "id": "663871.550462_1525175.738024", "name": "MH_6", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 663871.550461587961763, 1525175.738024139311165 ] } }, +{ "type": "Feature", "properties": { "_index": 19, "bedlevel": -3.0, "branchid": "pipe_9", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_7", "shape": null, "area": 1.0, "streetlevel": 6.2421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 5.4853769327396927e-07, "index_right": 20, "_streetlevel_dem": 6.2421875, "nodeid": "664048.325320_1525098.071112", "id": "664048.325320_1525098.071112", "name": "MH_7", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664048.325319660594687, 1525098.071112430887297 ] } }, +{ "type": "Feature", "properties": { "_index": 20, "bedlevel": -3.0, "branchid": "pipe_10", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_9", "shape": null, "area": 1.0, "streetlevel": 6.78125, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 1.5659834095829541e-07, "index_right": 21, "_streetlevel_dem": 6.78125, "nodeid": "664702.726926_1525750.098550", "id": "664702.726926_1525750.098550", "name": "MH_9", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664702.726926030125469, 1525750.098550153663382 ] } }, +{ "type": "Feature", "properties": { "_index": 20, "bedlevel": -3.0, "branchid": "pipe_10;pipe_11", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_8", "shape": null, "area": 1.0, "streetlevel": 7.8125, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 7.0812675756148753e-10, "index_right": 22, "_streetlevel_dem": 7.8125, "nodeid": "664481.894200_1525830.303300", "id": "664481.894200_1525830.303300", "name": "MH_8", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664481.894200000097044, 1525830.303300000727177 ] } }, +{ "type": "Feature", "properties": { "_index": 22, "bedlevel": -3.0, "branchid": "pipe_12", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_10", "shape": null, "area": 1.0, "streetlevel": 6.6328125, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 5.7336208882836857e-07, "index_right": 23, "_streetlevel_dem": 6.6328125, "nodeid": "664747.433497_1525729.649800", "id": "664747.433497_1525729.649800", "name": "MH_10", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664747.433496630517766, 1525729.649799561593682 ] } }, +{ "type": "Feature", "properties": { "_index": 23, "bedlevel": -3.0, "branchid": "pipe_13;pipe_15", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_15", "shape": null, "area": 1.0, "streetlevel": 7.3203125, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 5.8207660913467407e-10, "index_right": 24, "_streetlevel_dem": 7.3203125, "nodeid": "664849.475700_1525031.354500", "id": "664849.475700_1525031.354500", "name": "MH_15", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664849.475700000301003, 1525031.354499999433756 ] } }, +{ "type": "Feature", "properties": { "_index": 24, "bedlevel": -3.0, "branchid": "pipe_14", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_11", "shape": null, "area": 1.0, "streetlevel": 6.5625, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 5.3099907323260637e-07, "index_right": 25, "_streetlevel_dem": 6.5625, "nodeid": "665219.643113_1525514.959857", "id": "665219.643113_1525514.959857", "name": "MH_11", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 665219.643113493453711, 1525514.959856803994626 ] } }, +{ "type": "Feature", "properties": { "_index": 25, "bedlevel": -3.0, "branchid": "pipe_15", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_14", "shape": null, "area": 1.0, "streetlevel": 5.9453125, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 2.9945179934390397e-07, "index_right": 26, "_streetlevel_dem": 5.9453125, "nodeid": "664708.738621_1524483.144798", "id": "664708.738621_1524483.144798", "name": "MH_14", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 664708.738620752468705, 1524483.144798168679699 ] } }, +{ "type": "Feature", "properties": { "_index": 26, "bedlevel": -3.0, "branchid": "pipe_16", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_13", "shape": null, "area": 1.0, "streetlevel": 6.34375, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 4.136866578190493e-07, "index_right": 27, "_streetlevel_dem": 6.34375, "nodeid": "665277.574118_1525446.393195", "id": "665277.574118_1525446.393195", "name": "MH_13", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 665277.574117646785453, 1525446.393194784643129 ] } }, +{ "type": "Feature", "properties": { "_index": 27, "bedlevel": -3.0, "branchid": "pipe_17", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "MH_12", "shape": null, "area": 1.0, "streetlevel": 6.34375, "streetstoragearea": 500.0, "storagetype": "reservoir", "distance_right": 4.7975319107342047e-07, "index_right": 28, "_streetlevel_dem": 6.34375, "nodeid": "665292.615321_1525470.849516", "id": "665292.615321_1525470.849516", "name": "MH_12", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 665292.615320706507191, 1525470.849516379414126 ] } } ] } diff --git a/examples/dflowfm_local/geoms/pipe_nodes.geojson b/examples/dflowfm_local/geoms/pipe_nodes.geojson index 90a5c1bb..f7f42f93 100644 --- a/examples/dflowfm_local/geoms/pipe_nodes.geojson +++ b/examples/dflowfm_local/geoms/pipe_nodes.geojson @@ -2,25 +2,25 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_0", "branch_id": "pipe_4", "branchtype": "pipe", "branchid": "pipe_4", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_4" }, "geometry": { "type": "Point", "coordinates": [ 664438.813829420600086, 1525829.800284768920392 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_1", "branch_id": "pipe_4", "branchtype": "pipe", "branchid": "pipe_4", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_4" }, "geometry": { "type": "Point", "coordinates": [ 664429.038999999407679, 1526107.097999999299645 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_2", "branch_id": "pipe_5", "branchtype": "pipe", "branchid": "pipe_5", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_5" }, "geometry": { "type": "Point", "coordinates": [ 664190.385799999814481, 1525924.032600000267848 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_3", "branch_id": "pipe_6", "branchtype": "pipe", "branchid": "pipe_6", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_6" }, "geometry": { "type": "Point", "coordinates": [ 664217.490140905487351, 1525583.23970616585575 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_4", "branch_id": "pipe_7", "branchtype": "pipe", "branchid": "pipe_7", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_7" }, "geometry": { "type": "Point", "coordinates": [ 663936.864700614358298, 1525261.152571672573686 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_5", "branch_id": "pipe_8", "branchtype": "pipe", "branchid": "pipe_8", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_8" }, "geometry": { "type": "Point", "coordinates": [ 663871.550461587961763, 1525175.738024139311165 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_6", "branch_id": "pipe_9", "branchtype": "pipe", "branchid": "pipe_9", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_9" }, "geometry": { "type": "Point", "coordinates": [ 664048.325319660594687, 1525098.071112430887297 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_7", "branch_id": "pipe_10", "branchtype": "pipe", "branchid": "pipe_10", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_10" }, "geometry": { "type": "Point", "coordinates": [ 664702.726926030125469, 1525750.098550153663382 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_8", "branch_id": "pipe_10", "branchtype": "pipe", "branchid": "pipe_10", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_10" }, "geometry": { "type": "Point", "coordinates": [ 664481.894200000097044, 1525830.303300000727177 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_9", "branch_id": "pipe_11", "branchtype": "pipe", "branchid": "pipe_11", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_11" }, "geometry": { "type": "Point", "coordinates": [ 664474.13, 1526115.699999999254942 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_10", "branch_id": "pipe_12", "branchtype": "pipe", "branchid": "pipe_12", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_12" }, "geometry": { "type": "Point", "coordinates": [ 664747.433496630517766, 1525729.649799561593682 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_11", "branch_id": "pipe_12", "branchtype": "pipe", "branchid": "pipe_12", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_12" }, "geometry": { "type": "Point", "coordinates": [ 665030.18360000057146, 1525603.506899999454618 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_12", "branch_id": "pipe_13", "branchtype": "pipe", "branchid": "pipe_13", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_13" }, "geometry": { "type": "Point", "coordinates": [ 664849.475700000301003, 1525031.354499999433756 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_13", "branch_id": "pipe_13", "branchtype": "pipe", "branchid": "pipe_13", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_13" }, "geometry": { "type": "Point", "coordinates": [ 665115.70000000030268, 1524944.7899999988731 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_14", "branch_id": "pipe_14", "branchtype": "pipe", "branchid": "pipe_14", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_14" }, "geometry": { "type": "Point", "coordinates": [ 665219.643113493453711, 1525514.959856803994626 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_15", "branch_id": "pipe_15", "branchtype": "pipe", "branchid": "pipe_15", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_15" }, "geometry": { "type": "Point", "coordinates": [ 664708.738620752468705, 1524483.144798168679699 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_16", "branch_id": "pipe_16", "branchtype": "pipe", "branchid": "pipe_16", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_16" }, "geometry": { "type": "Point", "coordinates": [ 665277.574117646785453, 1525446.393194784643129 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_17", "branch_id": "pipe_16", "branchtype": "pipe", "branchid": "pipe_16", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_16" }, "geometry": { "type": "Point", "coordinates": [ 665356.868200001074001, 1525406.983500000322238 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_18", "branch_id": "pipe_17", "branchtype": "pipe", "branchid": "pipe_17", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_17" }, "geometry": { "type": "Point", "coordinates": [ 665292.615320706507191, 1525470.849516379414126 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_19", "branch_id": "pipe_17", "branchtype": "pipe", "branchid": "pipe_17", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_17" }, "geometry": { "type": "Point", "coordinates": [ 665369.906399999978021, 1525431.441199998836964 ] } } +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_0", "branch_id": "pipe_4", "branchid": "pipe_4", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_4" }, "geometry": { "type": "Point", "coordinates": [ 664438.813829420600086, 1525829.800284768920392 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_1", "branch_id": "pipe_4", "branchid": "pipe_4", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_4" }, "geometry": { "type": "Point", "coordinates": [ 664429.038999999407679, 1526107.097999999299645 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_2", "branch_id": "pipe_5", "branchid": "pipe_5", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_5" }, "geometry": { "type": "Point", "coordinates": [ 664190.385799999814481, 1525924.032600000267848 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_3", "branch_id": "pipe_6", "branchid": "pipe_6", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_6" }, "geometry": { "type": "Point", "coordinates": [ 664217.490140905487351, 1525583.23970616585575 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_4", "branch_id": "pipe_7", "branchid": "pipe_7", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_7" }, "geometry": { "type": "Point", "coordinates": [ 663936.864700614358298, 1525261.152571672573686 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_5", "branch_id": "pipe_8", "branchid": "pipe_8", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_8" }, "geometry": { "type": "Point", "coordinates": [ 663871.550461587961763, 1525175.738024139311165 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_6", "branch_id": "pipe_9", "branchid": "pipe_9", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_9" }, "geometry": { "type": "Point", "coordinates": [ 664048.325319660594687, 1525098.071112430887297 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_7", "branch_id": "pipe_10", "branchid": "pipe_10", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_10" }, "geometry": { "type": "Point", "coordinates": [ 664702.726926030125469, 1525750.098550153663382 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_8", "branch_id": "pipe_10", "branchid": "pipe_10", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_10" }, "geometry": { "type": "Point", "coordinates": [ 664481.894200000097044, 1525830.303300000727177 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_9", "branch_id": "pipe_11", "branchid": "pipe_11", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_11" }, "geometry": { "type": "Point", "coordinates": [ 664474.13, 1526115.699999999254942 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_10", "branch_id": "pipe_12", "branchid": "pipe_12", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_12" }, "geometry": { "type": "Point", "coordinates": [ 664747.433496630517766, 1525729.649799561593682 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_11", "branch_id": "pipe_12", "branchid": "pipe_12", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_12" }, "geometry": { "type": "Point", "coordinates": [ 665030.18360000057146, 1525603.506899999454618 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_12", "branch_id": "pipe_13", "branchid": "pipe_13", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_13" }, "geometry": { "type": "Point", "coordinates": [ 664849.475700000301003, 1525031.354499999433756 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_13", "branch_id": "pipe_13", "branchid": "pipe_13", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_13" }, "geometry": { "type": "Point", "coordinates": [ 665115.70000000030268, 1524944.7899999988731 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_14", "branch_id": "pipe_14", "branchid": "pipe_14", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_14" }, "geometry": { "type": "Point", "coordinates": [ 665219.643113493453711, 1525514.959856803994626 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_15", "branch_id": "pipe_15", "branchid": "pipe_15", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_15" }, "geometry": { "type": "Point", "coordinates": [ 664708.738620752468705, 1524483.144798168679699 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_16", "branch_id": "pipe_16", "branchid": "pipe_16", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_16" }, "geometry": { "type": "Point", "coordinates": [ 665277.574117646785453, 1525446.393194784643129 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_17", "branch_id": "pipe_16", "branchid": "pipe_16", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_16" }, "geometry": { "type": "Point", "coordinates": [ 665356.868200001074001, 1525406.983500000322238 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_18", "branch_id": "pipe_17", "branchid": "pipe_17", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_17" }, "geometry": { "type": "Point", "coordinates": [ 665292.615320706507191, 1525470.849516379414126 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_19", "branch_id": "pipe_17", "branchid": "pipe_17", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "shape": "circle", "diameter": 0.5, "ORIG_branchid": "pipe_17" }, "geometry": { "type": "Point", "coordinates": [ 665369.906399999978021, 1525431.441199998836964 ] } } ] } diff --git a/examples/dflowfm_local/geoms/pipes.geojson b/examples/dflowfm_local/geoms/pipes.geojson index e604ea79..0c634f01 100644 --- a/examples/dflowfm_local/geoms/pipes.geojson +++ b/examples/dflowfm_local/geoms/pipes.geojson @@ -2,19 +2,19 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_4", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_4", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_0_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664438.813829420600086, 1525829.800284768920392 ], [ 664429.038999999989755, 1526107.098 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_5", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_5", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_1_generated", "manhole_dn": "manhole_0_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664190.385799999814481, 1525924.032600000267848 ], [ 664438.813829420600086, 1525829.800284768920392 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_6", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_2_generated", "manhole_dn": "manhole_0_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664217.490140905487351, 1525583.23970616585575 ], [ 664438.813829420600086, 1525829.800284768920392 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_7", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_3_generated", "manhole_dn": "manhole_2_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 663936.864700614358298, 1525261.152571672573686 ], [ 664217.490140905487351, 1525583.23970616585575 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_8", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_4_generated", "manhole_dn": "manhole_3_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 663871.550461587961763, 1525175.738024139311165 ], [ 663897.086400000494905, 1525212.559499999275431 ], [ 663936.864700614358298, 1525261.152571672573686 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_9", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_5_generated", "manhole_dn": "manhole_4_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664048.325319660594687, 1525098.071112430887297 ], [ 663871.550461587961763, 1525175.738024139311165 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_10", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_6_generated", "manhole_dn": "manhole_7_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664702.726926030125469, 1525750.098550153663382 ], [ 664481.894200000097044, 1525830.303300000727177 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_11", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_7_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664481.894200000097044, 1525830.303300000727177 ], [ 664474.13, 1526115.7 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_12", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_8_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664747.433496630517766, 1525729.649799561593682 ], [ 664838.810497992672026, 1525698.612855288665742 ], [ 664907.926478271954693, 1525663.288345249835402 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_13", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_13", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_9_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664849.475700000301003, 1525031.354499999433756 ], [ 665115.699999999953434, 1524944.79 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_14", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_14", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_10_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665219.643113493453711, 1525514.959856803994626 ], [ 665030.18360000057146, 1525603.506899999454618 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_15", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_15", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_11_generated", "manhole_dn": "manhole_9_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664708.738620752468705, 1524483.144798168679699 ], [ 664849.475700000301003, 1525031.354499999433756 ], [ 664849.475700000301003, 1525031.354499999433756 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_16", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_16", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_12_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665277.574117646785453, 1525446.393194784643129 ], [ 665356.868200000026263, 1525406.9835 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_17", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_17", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_13_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665292.615320706507191, 1525470.849516379414126 ], [ 665369.906399999978021, 1525431.4412 ], [ 665369.906399999978021, 1525431.4412 ] ] } } +{ "type": "Feature", "properties": { "branchid": "pipe_4", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_4", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_0_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664438.813829420600086, 1525829.800284768920392 ], [ 664429.038999999989755, 1526107.098 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_5", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_5", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_1_generated", "manhole_dn": "manhole_0_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664190.385799999814481, 1525924.032600000267848 ], [ 664438.813829420600086, 1525829.800284768920392 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_6", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_2_generated", "manhole_dn": "manhole_0_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664217.490140905487351, 1525583.23970616585575 ], [ 664438.813829420600086, 1525829.800284768920392 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_7", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_3_generated", "manhole_dn": "manhole_2_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 663936.864700614358298, 1525261.152571672573686 ], [ 664217.490140905487351, 1525583.23970616585575 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_8", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_4_generated", "manhole_dn": "manhole_3_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 663871.550461587961763, 1525175.738024139311165 ], [ 663897.086400000494905, 1525212.559499999275431 ], [ 663936.864700614358298, 1525261.152571672573686 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_9", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_5_generated", "manhole_dn": "manhole_4_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664048.325319660594687, 1525098.071112430887297 ], [ 663871.550461587961763, 1525175.738024139311165 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_10", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_6_generated", "manhole_dn": "manhole_7_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664702.726926030125469, 1525750.098550153663382 ], [ 664481.894200000097044, 1525830.303300000727177 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_11", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_7_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664481.894200000097044, 1525830.303300000727177 ], [ 664474.13, 1526115.7 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_12", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_8_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664747.433496630517766, 1525729.649799561593682 ], [ 664838.810497992672026, 1525698.612855288665742 ], [ 664907.926478271954693, 1525663.288345249835402 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_13", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_13", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_9_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664849.475700000301003, 1525031.354499999433756 ], [ 665115.699999999953434, 1524944.79 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_14", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_14", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_10_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665219.643113493453711, 1525514.959856803994626 ], [ 665030.18360000057146, 1525603.506899999454618 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_15", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_15", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_11_generated", "manhole_dn": "manhole_9_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664708.738620752468705, 1524483.144798168679699 ], [ 664849.475700000301003, 1525031.354499999433756 ], [ 664849.475700000301003, 1525031.354499999433756 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_16", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_16", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_12_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665277.574117646785453, 1525446.393194784643129 ], [ 665356.868200000026263, 1525406.9835 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_17", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_17", "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_13_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665292.615320706507191, 1525470.849516379414126 ], [ 665369.906399999978021, 1525431.4412 ], [ 665369.906399999978021, 1525431.4412 ] ] } } ] } diff --git a/examples/dflowfm_local/geoms/rivers.geojson b/examples/dflowfm_local/geoms/rivers.geojson index 419ed91c..0216bc58 100644 --- a/examples/dflowfm_local/geoms/rivers.geojson +++ b/examples/dflowfm_local/geoms/rivers.geojson @@ -2,19 +2,19 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "river_1", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_1", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664057.966296999948099, 1526147.834882 ], [ 663918.391924358904362, 1525803.10090322420001 ], [ 663700.482064640615135, 1525466.331120023271069 ], [ 663353.045365229598247, 1525088.417517154943198 ], [ 662879.129516471526586, 1524643.454726681346074 ], [ 662793.794186791637912, 1524515.451732161454856 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "river_2", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_2", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664057.966296999948099, 1526147.834882 ], [ 664218.310854589915834, 1526625.788610660471022 ], [ 664218.310854589915834, 1527005.169120056321844 ], [ 664197.234159623389132, 1527152.705984821310267 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_1", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_1", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665115.699999999953434, 1524944.79 ], [ 665356.868200000026263, 1525406.9835 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_2", "branchorder": 2.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_2", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665356.868200000026263, 1525406.9835 ], [ 665369.906399999978021, 1525431.441199999069795 ], [ 665369.906399999978021, 1525431.4412 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_3", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_3", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665369.906399999978021, 1525431.4412 ], [ 665641.789999999804422, 1525937.96000000089407 ], [ 665641.789999999804422, 1525937.96000000089407 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_4", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_4", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665641.789999999804422, 1525937.96000000089407 ], [ 665560.620547444559634, 1525952.124135404126719 ], [ 665480.575254552299157, 1525953.687039414886385 ], [ 665416.820000000414439, 1525962.189999999245629 ], [ 665346.659376955241896, 1525982.895817694021389 ], [ 665271.309999999706633, 1526001.859999999403954 ], [ 665243.630000000470318, 1526003.289999998640269 ], [ 665243.630000000470318, 1526003.289999997941777 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_5", "branchorder": 3.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_5", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665243.630000000470318, 1526003.289999997941777 ], [ 665116.950000000419095, 1525983.029999999096617 ], [ 665051.90000000083819, 1525977.32 ], [ 664963.504724813159555, 1526014.666760261869058 ], [ 664918.370000000344589, 1526039.810000000521541 ], [ 664826.210000000428408, 1526041.519999999552965 ], [ 664752.459499345044605, 1526065.157490010838956 ], [ 664672.28994727297686, 1526086.417805780190974 ], [ 664642.852168873418123, 1526095.560649296734482 ], [ 664550.869999999529682, 1526115.410000000149012 ], [ 664474.13, 1526115.7 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_6", "branchorder": 4.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_6", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664474.13, 1526115.7 ], [ 664429.038999999989755, 1526107.098 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_7", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_7", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664429.038999999989755, 1526107.098 ], [ 664272.40999999945052, 1526129.970000000204891 ], [ 664169.979999999864958, 1526140.529999999562278 ], [ 664092.240000000223517, 1526143.2899999988731 ], [ 664057.966296999948099, 1526147.834882 ], [ 664057.966296999948099, 1526147.834882 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_8", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_8", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 666180.040000000037253, 1525894.769999999320135 ], [ 665891.336423385655507, 1526041.311705864733085 ], [ 665733.269999999320135, 1526117.310000000521541 ], [ 665733.269999999320135, 1526117.310000000521541 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_10", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_10", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665733.269999999320135, 1526117.310000000521541 ], [ 665641.789999999804422, 1525937.96000000089407 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_11", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_11", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664789.146172603359446, 1525073.346127192256972 ], [ 665015.157200000365265, 1525576.51439999951981 ], [ 665015.157200000365265, 1525576.514399999286979 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_12", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_12", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665015.157200000365265, 1525576.514399999286979 ], [ 665030.18360000057146, 1525603.506899999454618 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_13", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_13", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665030.18360000057146, 1525603.506899999454618 ], [ 665243.630000000470318, 1526003.289999997941777 ] ] } } +{ "type": "Feature", "properties": { "branchid": "river_1", "branchtype": "river", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_1", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664057.966296999948099, 1526147.834882 ], [ 663918.391924358904362, 1525803.10090322420001 ], [ 663700.482064640615135, 1525466.331120023271069 ], [ 663353.045365229598247, 1525088.417517154943198 ], [ 662879.129516471526586, 1524643.454726681346074 ], [ 662793.794186791637912, 1524515.451732161454856 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "river_2", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_2", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664057.966296999948099, 1526147.834882 ], [ 664218.310854589915834, 1526625.788610660471022 ], [ 664218.310854589915834, 1527005.169120056321844 ], [ 664197.234159623389132, 1527152.705984821310267 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_1", "branchtype": "river", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_1", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665115.699999999953434, 1524944.79 ], [ 665356.868200000026263, 1525406.9835 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_2", "branchtype": "river", "branchorder": 2.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_2", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665356.868200000026263, 1525406.9835 ], [ 665369.906399999978021, 1525431.441199999069795 ], [ 665369.906399999978021, 1525431.4412 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_3", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_3", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665369.906399999978021, 1525431.4412 ], [ 665641.789999999804422, 1525937.96000000089407 ], [ 665641.789999999804422, 1525937.96000000089407 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_4", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_4", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665641.789999999804422, 1525937.96000000089407 ], [ 665560.620547444559634, 1525952.124135404126719 ], [ 665480.575254552299157, 1525953.687039414886385 ], [ 665416.820000000414439, 1525962.189999999245629 ], [ 665346.659376955241896, 1525982.895817694021389 ], [ 665271.309999999706633, 1526001.859999999403954 ], [ 665243.630000000470318, 1526003.289999998640269 ], [ 665243.630000000470318, 1526003.289999997941777 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_5", "branchtype": "river", "branchorder": 3.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_5", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665243.630000000470318, 1526003.289999997941777 ], [ 665116.950000000419095, 1525983.029999999096617 ], [ 665051.90000000083819, 1525977.32 ], [ 664963.504724813159555, 1526014.666760261869058 ], [ 664918.370000000344589, 1526039.810000000521541 ], [ 664826.210000000428408, 1526041.519999999552965 ], [ 664752.459499345044605, 1526065.157490010838956 ], [ 664672.28994727297686, 1526086.417805780190974 ], [ 664642.852168873418123, 1526095.560649296734482 ], [ 664550.869999999529682, 1526115.410000000149012 ], [ 664474.13, 1526115.7 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_6", "branchtype": "river", "branchorder": 4.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_6", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664474.13, 1526115.7 ], [ 664429.038999999989755, 1526107.098 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_7", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_7", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664429.038999999989755, 1526107.098 ], [ 664272.40999999945052, 1526129.970000000204891 ], [ 664169.979999999864958, 1526140.529999999562278 ], [ 664092.240000000223517, 1526143.2899999988731 ], [ 664057.966296999948099, 1526147.834882 ], [ 664057.966296999948099, 1526147.834882 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_8", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_8", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 666180.040000000037253, 1525894.769999999320135 ], [ 665891.336423385655507, 1526041.311705864733085 ], [ 665733.269999999320135, 1526117.310000000521541 ], [ 665733.269999999320135, 1526117.310000000521541 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_10", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_10", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665733.269999999320135, 1526117.310000000521541 ], [ 665641.789999999804422, 1525937.96000000089407 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_11", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_11", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664789.146172603359446, 1525073.346127192256972 ], [ 665015.157200000365265, 1525576.51439999951981 ], [ 665015.157200000365265, 1525576.514399999286979 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_12", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_12", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665015.157200000365265, 1525576.514399999286979 ], [ 665030.18360000057146, 1525603.506899999454618 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_13", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_13", "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665030.18360000057146, 1525603.506899999454618 ], [ 665243.630000000470318, 1526003.289999997941777 ] ] } } ] } diff --git a/examples/dflowfm_local/geoms/rivers_nodes.geojson b/examples/dflowfm_local/geoms/rivers_nodes.geojson index 6e55c5f3..be50d994 100644 --- a/examples/dflowfm_local/geoms/rivers_nodes.geojson +++ b/examples/dflowfm_local/geoms/rivers_nodes.geojson @@ -2,22 +2,22 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_0", "branch_id": "branch_1", "branchtype": "river", "branchid": "branch_1", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_1" }, "geometry": { "type": "Point", "coordinates": [ 665115.70000000030268, 1524944.7899999988731 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_1", "branch_id": "branch_1", "branchtype": "river", "branchid": "branch_1", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_1" }, "geometry": { "type": "Point", "coordinates": [ 665356.868200001074001, 1525406.983500000322238 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_2", "branch_id": "branch_2", "branchtype": "river", "branchid": "branch_2", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_2" }, "geometry": { "type": "Point", "coordinates": [ 665369.906399999978021, 1525431.441199999069795 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_3", "branch_id": "branch_3", "branchtype": "river", "branchid": "branch_3", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_3" }, "geometry": { "type": "Point", "coordinates": [ 665369.906399999978021, 1525431.441199998836964 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_4", "branch_id": "branch_3", "branchtype": "river", "branchid": "branch_3", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_3" }, "geometry": { "type": "Point", "coordinates": [ 665641.789999999804422, 1525937.96000000089407 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_5", "branch_id": "branch_4", "branchtype": "river", "branchid": "branch_4", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_4" }, "geometry": { "type": "Point", "coordinates": [ 665243.630000000470318, 1526003.289999998640269 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_6", "branch_id": "branch_5", "branchtype": "river", "branchid": "branch_5", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_5" }, "geometry": { "type": "Point", "coordinates": [ 665243.630000000470318, 1526003.289999998174608 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_7", "branch_id": "branch_5", "branchtype": "river", "branchid": "branch_5", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_5" }, "geometry": { "type": "Point", "coordinates": [ 664474.13, 1526115.699999999254942 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_8", "branch_id": "branch_6", "branchtype": "river", "branchid": "branch_6", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_6" }, "geometry": { "type": "Point", "coordinates": [ 664429.038999999407679, 1526107.097999999299645 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_9", "branch_id": "branch_7", "branchtype": "river", "branchid": "branch_7", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_7" }, "geometry": { "type": "Point", "coordinates": [ 664057.966297403792851, 1526147.834882111055776 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_10", "branch_id": "branch_8", "branchtype": "river", "branchid": "branch_8", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_8" }, "geometry": { "type": "Point", "coordinates": [ 666180.040000000037253, 1525894.769999999320135 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_11", "branch_id": "branch_8", "branchtype": "river", "branchid": "branch_8", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_8" }, "geometry": { "type": "Point", "coordinates": [ 665733.269999999320135, 1526117.310000000521541 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_12", "branch_id": "branch_11", "branchtype": "river", "branchid": "branch_11", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_11" }, "geometry": { "type": "Point", "coordinates": [ 664789.146172603359446, 1525073.346127192256972 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_13", "branch_id": "branch_11", "branchtype": "river", "branchid": "branch_11", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_11" }, "geometry": { "type": "Point", "coordinates": [ 665015.157200000365265, 1525576.51439999951981 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_14", "branch_id": "branch_12", "branchtype": "river", "branchid": "branch_12", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_12" }, "geometry": { "type": "Point", "coordinates": [ 665015.157200000365265, 1525576.514399999286979 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_15", "branch_id": "branch_12", "branchtype": "river", "branchid": "branch_12", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_12" }, "geometry": { "type": "Point", "coordinates": [ 665030.18360000057146, 1525603.506899999454618 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_16", "branch_id": "branch_13", "branchtype": "river", "branchid": "branch_13", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_13" }, "geometry": { "type": "Point", "coordinates": [ 665243.630000000470318, 1526003.289999997941777 ] } } +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_0", "branch_id": "branch_1", "branchid": "branch_1", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_1" }, "geometry": { "type": "Point", "coordinates": [ 665115.70000000030268, 1524944.7899999988731 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_1", "branch_id": "branch_1", "branchid": "branch_1", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_1" }, "geometry": { "type": "Point", "coordinates": [ 665356.868200001074001, 1525406.983500000322238 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_2", "branch_id": "branch_2", "branchid": "branch_2", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_2" }, "geometry": { "type": "Point", "coordinates": [ 665369.906399999978021, 1525431.441199999069795 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_3", "branch_id": "branch_3", "branchid": "branch_3", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_3" }, "geometry": { "type": "Point", "coordinates": [ 665369.906399999978021, 1525431.441199998836964 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_4", "branch_id": "branch_3", "branchid": "branch_3", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_3" }, "geometry": { "type": "Point", "coordinates": [ 665641.789999999804422, 1525937.96000000089407 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_5", "branch_id": "branch_4", "branchid": "branch_4", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_4" }, "geometry": { "type": "Point", "coordinates": [ 665243.630000000470318, 1526003.289999998640269 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_6", "branch_id": "branch_5", "branchid": "branch_5", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_5" }, "geometry": { "type": "Point", "coordinates": [ 665243.630000000470318, 1526003.289999998174608 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_7", "branch_id": "branch_5", "branchid": "branch_5", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_5" }, "geometry": { "type": "Point", "coordinates": [ 664474.13, 1526115.699999999254942 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_8", "branch_id": "branch_6", "branchid": "branch_6", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_6" }, "geometry": { "type": "Point", "coordinates": [ 664429.038999999407679, 1526107.097999999299645 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_9", "branch_id": "branch_7", "branchid": "branch_7", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_7" }, "geometry": { "type": "Point", "coordinates": [ 664057.966297403792851, 1526147.834882111055776 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_10", "branch_id": "branch_8", "branchid": "branch_8", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_8" }, "geometry": { "type": "Point", "coordinates": [ 666180.040000000037253, 1525894.769999999320135 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_11", "branch_id": "branch_8", "branchid": "branch_8", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_8" }, "geometry": { "type": "Point", "coordinates": [ 665733.269999999320135, 1526117.310000000521541 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_12", "branch_id": "branch_11", "branchid": "branch_11", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_11" }, "geometry": { "type": "Point", "coordinates": [ 664789.146172603359446, 1525073.346127192256972 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_13", "branch_id": "branch_11", "branchid": "branch_11", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_11" }, "geometry": { "type": "Point", "coordinates": [ 665015.157200000365265, 1525576.51439999951981 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_14", "branch_id": "branch_12", "branchid": "branch_12", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_12" }, "geometry": { "type": "Point", "coordinates": [ 665015.157200000365265, 1525576.514399999286979 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_15", "branch_id": "branch_12", "branchid": "branch_12", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_12" }, "geometry": { "type": "Point", "coordinates": [ 665030.18360000057146, 1525603.506899999454618 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_16", "branch_id": "branch_13", "branchid": "branch_13", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "branch_13" }, "geometry": { "type": "Point", "coordinates": [ 665243.630000000470318, 1526003.289999997941777 ] } } ] } diff --git a/examples/dflowfm_piave/dflowfm/DFlowFM.mdu b/examples/dflowfm_piave/dflowfm/DFlowFM.mdu index 0050a282..bdb0ca0a 100644 --- a/examples/dflowfm_piave/dflowfm/DFlowFM.mdu +++ b/examples/dflowfm_piave/dflowfm/DFlowFM.mdu @@ -9,59 +9,59 @@ autoStart = 0 # Autostart simulation after loading MDU o pathsRelativeToParent = 0 # Whether or not (1/0) to resolve file names (e.g. inside the *.ext file) relative to their direct parent, instead of to the toplevel MDU working dir [Geometry] -netFile = fm_net.nc # The net file <*_net.nc> -bathymetryFile = # Removed since March 2022. See [geometry] keyword BedLevelFile. -dryPointsFile = # Dry points file <*.xyz>, third column dummy z values, or polygon file <*.pol>. -structureFile = # File <*.ini> containing list of hydraulic structures. -iniFieldFile = fieldFile.ini # Initial and parameter field file <*.ini>. -waterLevIniFile = # Initial water levels sample file <*.xyz>. -landBoundaryFile = # Only for plotting. -thinDamFile = # <*_thd.pli>, Polyline(s) for tracing thin dams. -fixedWeirFile = # <*_fxw.pliz>, Polyline(s) x, y, z, z = fixed weir top levels (formerly fixed weir). -pillarFile = # <*_pillar.pliz>, Polyline file containing four colums with x, y, diameter and Cd coefficient for bridge pillars. -useCaching = 0 # Use caching for geometrical/network-related items (0: no, 1: yes) (section C.19). -vertPlizFile = # <*_vlay.pliz>), = pliz with x, y, Z, first Z = nr of layers, second Z = laytyp. -frictFile = roughness_M-0p023.ini;roughness_W-0p003.ini # Location of the files with roughness data for 1D. -crossDefFile = crsdef.ini # Cross section definitions for all cross section shapes. -crossLocFile = crsloc.ini # Location definitions of the cross sections on a 1D network. -storageNodeFile = nodeFile.ini # File containing the specification of storage nodes and/or manholes to add extra storage to 1D models. -1d2dLinkFile = # File containing the custom parameterization of 1D-2D links. -profLocFile = # <*_proflocation.xyz>) x, y, z, z = profile refnumber. -profDefFile = # <*_profdefinition.def>) definition for all profile nrs. -profDefXyzFile = # <*_profdefinition.def>) definition for all profile nrs. -manholeFile = # File containing manholes (e.g. <*.dat>). -partitionFile = # <*_part.pol>, polyline(s) x, y. +netFile = fm_net.nc # The net file <*_net.nc> +bathymetryFile = # Removed since March 2022. See [geometry] keyword BedLevelFile. +dryPointsFile = # Dry points file <*.xyz>, third column dummy z values, or polygon file <*.pol>. +structureFile = # File <*.ini> containing list of hydraulic structures. +iniFieldFile = fieldFile.ini # Initial and parameter field file <*.ini>. +waterLevIniFile = # Initial water levels sample file <*.xyz>. +landBoundaryFile = # Only for plotting. +thinDamFile = # <*_thd.pli>, Polyline(s) for tracing thin dams. +fixedWeirFile = # <*_fxw.pliz>, Polyline(s) x, y, z, z = fixed weir top levels (formerly fixed weir). +pillarFile = # <*_pillar.pliz>, Polyline file containing four colums with x, y, diameter and Cd coefficient for bridge pillars. +useCaching = 0 # Use caching for geometrical/network-related items (0: no, 1: yes) (section C.19). +vertPlizFile = # <*_vlay.pliz>), = pliz with x, y, Z, first Z = nr of layers, second Z = laytyp. +frictFile = roughness_Manning_0.023.ini;roughness_WhiteColeBrook_0.003.ini # Location of the files with roughness data for 1D. +crossDefFile = crsdef.ini # Cross section definitions for all cross section shapes. +crossLocFile = crsloc.ini # Location definitions of the cross sections on a 1D network. +storageNodeFile = nodeFile.ini # File containing the specification of storage nodes and/or manholes to add extra storage to 1D models. +1d2dLinkFile = # File containing the custom parameterization of 1D-2D links. +profLocFile = # <*_proflocation.xyz>) x, y, z, z = profile refnumber. +profDefFile = # <*_profdefinition.def>) definition for all profile nrs. +profDefXyzFile = # <*_profdefinition.def>) definition for all profile nrs. +manholeFile = # File containing manholes (e.g. <*.dat>). +partitionFile = # <*_part.pol>, polyline(s) x, y. uniformWidth1D = 2.0 -dxWuiMin2D = 0.0 # Smallest fraction dx/wu , set dx > Dxwuimin2D*wu -waterLevIni = 0.0 # Initial water level. -bedLevUni = -5.0 # Uniform bed level [m], (only if bedlevtype>=3), used at missing z values in netfile. -bedSlope = 0.0 # Bed slope inclination, sets zk = bedlevuni + x*bedslope ans sets zbndz = xbndz*bedslope. -bedLevType = 3 # 1: at cell center (tiles xz,yz,bl,bob=max(bl)), 2: at face (tiles xu,yu,blu,bob=blu), 3: at face (using mean node values), 4: at face (using min node values), 5: at face (using max node values), 6: with bl based on node values. -blMeanBelow = -999.0 # if not -999d0, below this level [m] the cell centre bedlevel is the mean of surrouding netnodes. -blMinAbove = -999.0 # if not -999d0, above this level [m] the cell centre bedlevel is the min of surrouding netnodes. -angLat = 0.0 # Angle of latitude S-N [deg], 0=no Coriolis. -angLon = 0.0 # Angle of longitude E-W [deg], 0=Greenwich Mean Time. -conveyance2D = -1 # -1:R=HU, 0:R=H, 1:R=A/P, 2:K=analytic-1D conv, 3:K=analytic-2D conv. -nonlin1D = 1 # Non-linear 1D volumes, applicable for models with closed cross sections. 1=treat closed sections as partially open by using a Preissmann slot, 2=Nested Newton approach, 3=Partial Nested Newton approach. -nonlin2D = 0 # Non-linear 2D volumes, only i.c.m. ibedlevtype = 3 and Conveyance2D>=1. -sillHeightMin = 0.0 # Fixed weir only active if both ground heights are larger than this value [m]. -makeOrthoCenters = 0 # (1: yes, 0: no) switch from circumcentres to orthocentres in geominit. -dCenterInside = 1.0 # limit cell center; 1.0:in cell <-> 0.0:on c/g. -baMin = 1e-06 # Minimum grid cell area [m2], i.c.m. cutcells. -openBoundaryTolerance = 3.0 # Search tolerance factor between boundary polyline and grid cells. [Unit: in cell size units (i.e., not meters)]. -renumberFlowNodes = 1 # Renumber the flow nodes (1: yes, 0: no). -kmx = 0 # Number of vertical layers. -layerType = 1 # Number of vertical layers. -numTopSig = 0 # Number of sigma-layers on top of z-layers. -numTopSigUniform = 1 # Spatially constant number of sigma layers above z-layers in a z-sigma model (1: yes, 0: no, spatially varying) -sigmaGrowthFactor = 1.0 # layer thickness growth factor from bed up. -dzTop = # Z-layer thickness of layers above level Dztopuniabovez -floorLevTopLay = # Floor level of top layer -dzTopUniAboveZ = # Above this level layers will have uniform dzTop, below we use sigmaGrowthFactor -keepZLayeringAtBed = 2 # 0:possibly very thin layer at bed, 1:bedlayerthickness == zlayerthickness, 2=equal thickness first two layers -dxDoubleAt1DEndNodes = 1 # Whether a 1D grid cell at the end of a network has to be extended with 0.5Δx. -changeVelocityAtStructures = 0 # Ignore structure dimensions for the velocity at hydraulic structures, when calculating the surrounding cell centered flow velocities. -changeStructureDimensions = 1 # Change the structure dimensions in case these are inconsistent with the channel dimensions. +dxWuiMin2D = 0.0 # Smallest fraction dx/wu , set dx > Dxwuimin2D*wu +waterLevIni = 0.0 # Initial water level. +bedLevUni = -5.0 # Uniform bed level [m], (only if bedlevtype>=3), used at missing z values in netfile. +bedSlope = 0.0 # Bed slope inclination, sets zk = bedlevuni + x*bedslope ans sets zbndz = xbndz*bedslope. +bedLevType = 3 # 1: at cell center (tiles xz,yz,bl,bob=max(bl)), 2: at face (tiles xu,yu,blu,bob=blu), 3: at face (using mean node values), 4: at face (using min node values), 5: at face (using max node values), 6: with bl based on node values. +blMeanBelow = -999.0 # if not -999d0, below this level [m] the cell centre bedlevel is the mean of surrouding netnodes. +blMinAbove = -999.0 # if not -999d0, above this level [m] the cell centre bedlevel is the min of surrouding netnodes. +angLat = 0.0 # Angle of latitude S-N [deg], 0=no Coriolis. +angLon = 0.0 # Angle of longitude E-W [deg], 0=Greenwich Mean Time. +conveyance2D = -1 # -1:R=HU, 0:R=H, 1:R=A/P, 2:K=analytic-1D conv, 3:K=analytic-2D conv. +nonlin1D = 1 # Non-linear 1D volumes, applicable for models with closed cross sections. 1=treat closed sections as partially open by using a Preissmann slot, 2=Nested Newton approach, 3=Partial Nested Newton approach. +nonlin2D = 0 # Non-linear 2D volumes, only i.c.m. ibedlevtype = 3 and Conveyance2D>=1. +sillHeightMin = 0.0 # Fixed weir only active if both ground heights are larger than this value [m]. +makeOrthoCenters = 0 # (1: yes, 0: no) switch from circumcentres to orthocentres in geominit. +dCenterInside = 1.0 # limit cell center; 1.0:in cell <-> 0.0:on c/g. +baMin = 1e-06 # Minimum grid cell area [m2], i.c.m. cutcells. +openBoundaryTolerance = 3.0 # Search tolerance factor between boundary polyline and grid cells. [Unit: in cell size units (i.e., not meters)]. +renumberFlowNodes = 1 # Renumber the flow nodes (1: yes, 0: no). +kmx = 0 # Number of vertical layers. +layerType = 1 # Number of vertical layers. +numTopSig = 0 # Number of sigma-layers on top of z-layers. +numTopSigUniform = 1 # Spatially constant number of sigma layers above z-layers in a z-sigma model (1: yes, 0: no, spatially varying) +sigmaGrowthFactor = 1.0 # layer thickness growth factor from bed up. +dzTop = # Z-layer thickness of layers above level Dztopuniabovez +floorLevTopLay = # Floor level of top layer +dzTopUniAboveZ = # Above this level layers will have uniform dzTop, below we use sigmaGrowthFactor +keepZLayeringAtBed = 2 # 0:possibly very thin layer at bed, 1:bedlayerthickness == zlayerthickness, 2=equal thickness first two layers +dxDoubleAt1DEndNodes = 1 # Whether a 1D grid cell at the end of a network has to be extended with 0.5Δx. +changeVelocityAtStructures = 0 # Ignore structure dimensions for the velocity at hydraulic structures, when calculating the surrounding cell centered flow velocities. +changeStructureDimensions = 1 # Change the structure dimensions in case these are inconsistent with the channel dimensions. [VolumeTables] useVolumeTables = 0 # Use volume tables for 1D grid cells (1: yes, 0 = no). diff --git a/examples/dflowfm_piave/dflowfm/bnd.ext b/examples/dflowfm_piave/dflowfm/bnd.ext index edf9019f..0985fd2a 100644 --- a/examples/dflowfm_piave/dflowfm/bnd.ext +++ b/examples/dflowfm_piave/dflowfm/bnd.ext @@ -7,20 +7,20 @@ fileType = extForce [Boundary] quantity = waterlevelbnd nodeId = 1383191.056228_5854440.811426 -forcingFile = boundaryconditions1d_waterlevelbnd.bc +forcingFile = boundarycondition1d.bc [Boundary] quantity = waterlevelbnd nodeId = 1394694.070276_5867648.108302 -forcingFile = boundaryconditions1d_waterlevelbnd.bc +forcingFile = boundarycondition1d.bc [Boundary] quantity = waterlevelbnd nodeId = 1386066.809740_5868052.726493 -forcingFile = boundaryconditions1d_waterlevelbnd.bc +forcingFile = boundarycondition1d.bc [Boundary] quantity = waterlevelbnd nodeId = 1391540.018037_5858077.577220 -forcingFile = boundaryconditions1d_waterlevelbnd.bc +forcingFile = boundarycondition1d.bc diff --git a/examples/dflowfm_piave/dflowfm/fieldFile.ini b/examples/dflowfm_piave/dflowfm/fieldFile.ini index 67c04d70..42d38f31 100644 --- a/examples/dflowfm_piave/dflowfm/fieldFile.ini +++ b/examples/dflowfm_piave/dflowfm/fieldFile.ini @@ -11,7 +11,7 @@ dataFileType = GeoTIFF # Type of dataFile. interpolationMethod = averaging # Type of (spatial) interpolation. operand = O # How this data is combined with previous data for the same quantity (if any). averagingType = nearestNb # Type of averaging, if interpolationMethod=averaging . -averagingRelSize = 0.37 # Relative search cell size for averaging. +averagingRelSize = 1.01 # Relative search cell size for averaging. averagingNumMin = 1 # Minimum number of points in averaging. Must be ≥ 1. averagingPercentile = 0 # Percentile value for which data values to include in averaging. 0.0 means off. extrapolationMethod = 0 # Option for (spatial) extrapolation. diff --git a/examples/dflowfm_piave/dflowfm/fm_net.nc b/examples/dflowfm_piave/dflowfm/fm_net.nc index d44c48cca3a3ef478df4ef52ed37431749c2ff77..c8f776c12a89ad8e32392d71de7a675d070836ef 100644 GIT binary patch delta 80 zcmaDc#q7ltvki(&yq3B~h6;v;R>sCw21d<#OznD1j6e*cnSq!Eh*^P{4T#x+m;;D8 SftU-3xq+BxyB-s-RR;hsXA&0x delta 80 zcmaDc#q7ltvki(&ycW8Kh6;wJRt82^#^%j>OznD1j6e*cnSq!Eh*^P{4T#x+m;;D8 SftU-3xq+BxyB-s-RR;htxe^@! diff --git a/examples/dflowfm_piave/dimr_config.xml b/examples/dflowfm_piave/dimr_config.xml index d8decb71..976416d5 100644 --- a/examples/dflowfm_piave/dimr_config.xml +++ b/examples/dflowfm_piave/dimr_config.xml @@ -3,7 +3,7 @@ 1.3 hydrolib-core 0.5.2 - 2023-08-11T13:02:13.787118 + 2023-09-21T09:32:17.058397 diff --git a/examples/dflowfm_piave/geoms/boundaries.geojson b/examples/dflowfm_piave/geoms/boundaries.geojson index ef44e6f7..f037f6b3 100644 --- a/examples/dflowfm_piave/geoms/boundaries.geojson +++ b/examples/dflowfm_piave/geoms/boundaries.geojson @@ -2,37 +2,37 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::3857" } }, "features": [ -{ "type": "Feature", "properties": { "level_0": 1383191.056227589, "level_1": 5854440.8114257297, "height": 17.349960327148438, "width": 60.93007025, "bedlev": 701.4000244140625, "branchid": "river_5", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_5", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": 6, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "where": "downstream", "distance_right": 4.9175380812341708e-07, "nodeid": "1383191.056228_5854440.811426" }, "geometry": { "type": "Point", "coordinates": [ 1383191.056227589026093, 5854440.811425729654729 ] } }, -{ "type": "Feature", "properties": { "level_0": 1393846.8667426864, "level_1": 5859166.3015384898, "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E140", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 168, "elevtn_up": 1144.300048828125, "elevtn_dn": 1112.5, "invlev_up": 1141.800048828125, "invlev_dn": 1110.0, "where": "downstream", "distance_right": 5.8166784782944824e-07, "nodeid": "1393846.866743_5859166.301538" }, "geometry": { "type": "Point", "coordinates": [ 1393846.866742686368525, 5859166.301538489758968 ] } }, -{ "type": "Feature", "properties": { "level_0": 1386078.4202513243, "level_1": 5859854.3928082353, "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1239", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 364, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "where": "downstream", "distance_right": 4.0088765079104887e-07, "nodeid": "1386078.420251_5859854.392808" }, "geometry": { "type": "Point", "coordinates": [ 1386078.420251324307173, 5859854.392808235250413 ] } }, -{ "type": "Feature", "properties": { "level_0": 1386045.2509392484, "level_1": 5859913.8590362957, "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E276", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 447, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "where": "downstream", "distance_right": 3.8584702415109949e-07, "nodeid": "1386045.250939_5859913.859036" }, "geometry": { "type": "Point", "coordinates": [ 1386045.250939248362556, 5859913.859036295674741 ] } }, -{ "type": "Feature", "properties": { "level_0": 1384484.1807617808, "level_1": 5857184.3018050948, "height": null, "width": null, "bedlev": null, "branchid": "pipe_11_E9", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 458, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "where": "downstream", "distance_right": 2.3880128290434959e-07, "nodeid": "1384484.180762_5857184.301805" }, "geometry": { "type": "Point", "coordinates": [ 1384484.18076178082265, 5857184.301805094815791 ] } }, -{ "type": "Feature", "properties": { "level_0": 1384480.7748306419, "level_1": 5857195.2444554009, "height": null, "width": null, "bedlev": null, "branchid": "pipe_15_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_15", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_15", "diameter": 0.5, "index_right": 467, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "where": "downstream", "distance_right": 5.3722077541611869e-07, "nodeid": "1384480.774831_5857195.244455" }, "geometry": { "type": "Point", "coordinates": [ 1384480.774830641923472, 5857195.244455400854349 ] } }, -{ "type": "Feature", "properties": { "level_0": 1385834.1594623995, "level_1": 5858793.8441787036, "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E47", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 519, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "where": "downstream", "distance_right": 4.9733410300668418e-07, "nodeid": "1385834.159462_5858793.844179" }, "geometry": { "type": "Point", "coordinates": [ 1385834.15946239954792, 5858793.844178703613579 ] } }, -{ "type": "Feature", "properties": { "level_0": 1385177.8775195002, "level_1": 5858363.9756671879, "height": null, "width": null, "bedlev": null, "branchid": "pipe_21_E4", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 525, "elevtn_up": 758.9000244140625, "elevtn_dn": 756.79998779296875, "invlev_up": 756.4000244140625, "invlev_dn": 754.29998779296875, "where": "downstream", "distance_right": 5.341153742051576e-07, "nodeid": "1385177.877520_5858363.975667" }, "geometry": { "type": "Point", "coordinates": [ 1385177.877519500209019, 5858363.975667187944055 ] } }, -{ "type": "Feature", "properties": { "level_0": 1384799.2182603152, "level_1": 5858488.5922634779, "height": null, "width": null, "bedlev": null, "branchid": "pipe_23_E1", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_23", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": 0.5, "index_right": 528, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "where": "downstream", "distance_right": 5.7240456036556167e-07, "nodeid": "1384799.218260_5858488.592263" }, "geometry": { "type": "Point", "coordinates": [ 1384799.21826031524688, 5858488.592263477854431 ] } }, -{ "type": "Feature", "properties": { "level_0": 1385472.2180530226, "level_1": 5858925.2730725091, "height": null, "width": null, "bedlev": null, "branchid": "pipe_25_E2", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_25", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": 0.5, "index_right": 535, "elevtn_up": 791.20001220703125, "elevtn_dn": 783.0, "invlev_up": 788.70001220703125, "invlev_dn": 780.5, "where": "downstream", "distance_right": 4.913263386404469e-07, "nodeid": "1385472.218053_5858925.273073" }, "geometry": { "type": "Point", "coordinates": [ 1385472.218053022632375, 5858925.273072509095073 ] } }, -{ "type": "Feature", "properties": { "level_0": 1388962.2407159139, "level_1": 5860301.717001454, "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E73", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 620, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "where": "downstream", "distance_right": 4.6166295054686266e-07, "nodeid": "1388962.240716_5860301.717001" }, "geometry": { "type": "Point", "coordinates": [ 1388962.240715913940221, 5860301.717001453973353 ] } }, -{ "type": "Feature", "properties": { "level_0": 1386273.1738117875, "level_1": 5859335.3654602878, "height": null, "width": null, "bedlev": null, "branchid": "pipe_33_E12", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 633, "elevtn_up": 717.60003662109375, "elevtn_dn": 711.0, "invlev_up": 715.10003662109375, "invlev_dn": 708.5, "where": "downstream", "distance_right": 3.577770704512787e-07, "nodeid": "1386273.173812_5859335.365460" }, "geometry": { "type": "Point", "coordinates": [ 1386273.173811787506565, 5859335.36546028777957 ] } }, -{ "type": "Feature", "properties": { "level_0": 1387692.1617963261, "level_1": 5866783.4206203762, "height": null, "width": null, "bedlev": null, "branchid": "pipe_42_E7", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 867, "elevtn_up": 816.10003662109375, "elevtn_dn": 802.4000244140625, "invlev_up": 813.60003662109375, "invlev_dn": 799.9000244140625, "where": "downstream", "distance_right": 4.9781434926194598e-07, "nodeid": "1387692.161796_5866783.420620" }, "geometry": { "type": "Point", "coordinates": [ 1387692.161796326050535, 5866783.420620376244187 ] } }, -{ "type": "Feature", "properties": { "level_0": 1387975.2799954726, "level_1": 5866107.4257222451, "height": null, "width": null, "bedlev": null, "branchid": "pipe_48_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_48", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_48", "diameter": 0.5, "index_right": 892, "elevtn_up": 803.9000244140625, "elevtn_dn": 786.29998779296875, "invlev_up": 801.4000244140625, "invlev_dn": 783.79998779296875, "where": "downstream", "distance_right": 5.3234291644079913e-07, "nodeid": "1387975.279995_5866107.425722" }, "geometry": { "type": "Point", "coordinates": [ 1387975.279995472636074, 5866107.425722245126963 ] } }, -{ "type": "Feature", "properties": { "level_0": 1394694.0702762168, "level_1": 5867648.108302163, "height": 22.5, "width": 60.500781333333329, "bedlev": 865.60003662109375, "branchid": "river_1", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_1", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": 0, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "where": "upstream", "distance_right": 2.7120132961912311e-07, "nodeid": "1394694.070276_5867648.108302" }, "geometry": { "type": "Point", "coordinates": [ 1394694.070276216836646, 5867648.108302162960172 ] } }, -{ "type": "Feature", "properties": { "level_0": 1386066.8097397459, "level_1": 5868052.7264932301, "height": 13.574996948242188, "width": 63.595319, "bedlev": 813.29998779296875, "branchid": "river_2", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_2", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": 2, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "where": "upstream", "distance_right": 3.4269831423038173e-07, "nodeid": "1386066.809740_5868052.726493" }, "geometry": { "type": "Point", "coordinates": [ 1386066.809739745920524, 5868052.726493230089545 ] } }, -{ "type": "Feature", "properties": { "level_0": 1391540.018037077, "level_1": 5858077.5772200329, "height": 21.70001220703125, "width": 50.0, "bedlev": 952.79998779296875, "branchid": "river_3", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_3", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": 3, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "where": "upstream", "distance_right": 8.367694927529332e-08, "nodeid": "1391540.018037_5858077.577220" }, "geometry": { "type": "Point", "coordinates": [ 1391540.01803707703948, 5858077.577220032922924 ] } }, -{ "type": "Feature", "properties": { "level_0": 1388521.2575925963, "level_1": 5855362.0276134778, "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1045", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 169, "elevtn_up": 968.29998779296875, "elevtn_dn": 968.29998779296875, "invlev_up": 965.79998779296875, "invlev_dn": 965.79998779296875, "where": "upstream", "distance_right": 6.2550722664998962e-07, "nodeid": "1388521.257593_5855362.027613" }, "geometry": { "type": "Point", "coordinates": [ 1388521.257592596346512, 5855362.027613477781415 ] } }, -{ "type": "Feature", "properties": { "level_0": 1384050.267680947, "level_1": 5856698.7020015484, "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E195", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 365, "elevtn_up": 814.29998779296875, "elevtn_dn": 802.9000244140625, "invlev_up": 811.79998779296875, "invlev_dn": 800.4000244140625, "where": "upstream", "distance_right": 4.5480020130277707e-07, "nodeid": "1384050.267681_5856698.702002" }, "geometry": { "type": "Point", "coordinates": [ 1384050.267680946970358, 5856698.702001548372209 ] } }, -{ "type": "Feature", "properties": { "level_0": 1384196.86181646, "level_1": 5856829.8804841097, "height": null, "width": null, "bedlev": null, "branchid": "pipe_11_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 448, "elevtn_up": 800.79998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 798.29998779296875, "invlev_dn": 798.29998779296875, "where": "upstream", "distance_right": 4.7301652606593837e-07, "nodeid": "1384196.861816_5856829.880484" }, "geometry": { "type": "Point", "coordinates": [ 1384196.861816460033879, 5856829.88048410974443 ] } }, -{ "type": "Feature", "properties": { "level_0": 1384289.0655242952, "level_1": 5856954.9478410175, "height": null, "width": null, "bedlev": null, "branchid": "pipe_12_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 459, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "where": "upstream", "distance_right": 2.9575907640532436e-07, "nodeid": "1384289.065524_5856954.947841" }, "geometry": { "type": "Point", "coordinates": [ 1384289.06552429520525, 5856954.947841017507017 ] } }, -{ "type": "Feature", "properties": { "level_0": 1384512.4849668304, "level_1": 5857248.8580293376, "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 471, "elevtn_up": 805.0, "elevtn_dn": 796.29998779296875, "invlev_up": 802.5, "invlev_dn": 793.79998779296875, "where": "upstream", "distance_right": 3.7745466738450301e-07, "nodeid": "1384512.484967_5857248.858029" }, "geometry": { "type": "Point", "coordinates": [ 1384512.484966830350459, 5857248.858029337599874 ] } }, -{ "type": "Feature", "properties": { "level_0": 1385352.4717880946, "level_1": 5858398.702550319, "height": null, "width": null, "bedlev": null, "branchid": "pipe_21_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 520, "elevtn_up": 756.29998779296875, "elevtn_dn": 765.0, "invlev_up": 753.79998779296875, "invlev_dn": 762.5, "where": "upstream", "distance_right": 3.3313663649888272e-07, "nodeid": "1385352.471788_5858398.702550" }, "geometry": { "type": "Point", "coordinates": [ 1385352.471788094611838, 5858398.70255031902343 ] } }, -{ "type": "Feature", "properties": { "level_0": 1384748.1072519517, "level_1": 5858475.4653943758, "height": null, "width": null, "bedlev": null, "branchid": "pipe_23_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_23", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": 0.5, "index_right": 526, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "where": "upstream", "distance_right": 3.7932856782999725e-07, "nodeid": "1384748.107252_5858475.465394" }, "geometry": { "type": "Point", "coordinates": [ 1384748.107251951703802, 5858475.46539437584579 ] } }, -{ "type": "Feature", "properties": { "level_0": 1385425.8717415037, "level_1": 5858809.5220389515, "height": null, "width": null, "bedlev": null, "branchid": "pipe_25_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_25", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": 0.5, "index_right": 532, "elevtn_up": 786.79998779296875, "elevtn_dn": 791.20001220703125, "invlev_up": 784.29998779296875, "invlev_dn": 788.70001220703125, "where": "upstream", "distance_right": 4.9875171671174047e-07, "nodeid": "1385425.871742_5858809.522039" }, "geometry": { "type": "Point", "coordinates": [ 1385425.871741503709927, 5858809.522038951516151 ] } }, -{ "type": "Feature", "properties": { "level_0": 1385861.3725137978, "level_1": 5858893.8325690301, "height": null, "width": null, "bedlev": null, "branchid": "pipe_29_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_29", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_29", "diameter": 0.5, "index_right": 536, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "where": "upstream", "distance_right": 2.0428258687376185e-07, "nodeid": "1385861.372514_5858893.832569" }, "geometry": { "type": "Point", "coordinates": [ 1385861.372513797832653, 5858893.832569030113518 ] } }, -{ "type": "Feature", "properties": { "level_0": 1387137.2230088995, "level_1": 5858981.7231069598, "height": null, "width": null, "bedlev": null, "branchid": "pipe_30_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 538, "elevtn_up": 769.4000244140625, "elevtn_dn": 769.4000244140625, "invlev_up": 766.9000244140625, "invlev_dn": 766.9000244140625, "where": "upstream", "distance_right": 1.0826199317136784e-07, "nodeid": "1387137.223009_5858981.723107" }, "geometry": { "type": "Point", "coordinates": [ 1387137.22300889948383, 5858981.723106959834695 ] } }, -{ "type": "Feature", "properties": { "level_0": 1386030.9264584926, "level_1": 5859869.8815911002, "height": null, "width": null, "bedlev": null, "branchid": "pipe_36_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_36", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_36", "diameter": 0.5, "index_right": 726, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "where": "upstream", "distance_right": 5.0283226172582603e-07, "nodeid": "1386030.926458_5859869.881591" }, "geometry": { "type": "Point", "coordinates": [ 1386030.926458492642269, 5859869.881591100245714 ] } }, -{ "type": "Feature", "properties": { "level_0": 1386043.3811057615, "level_1": 5859908.1192919631, "height": null, "width": null, "bedlev": null, "branchid": "pipe_37_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_37", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_37", "diameter": 0.5, "index_right": 727, "elevtn_up": 766.29998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 778.29998779296875, "where": "upstream", "distance_right": 2.4131141216608354e-07, "nodeid": "1386043.381106_5859908.119292" }, "geometry": { "type": "Point", "coordinates": [ 1386043.381105761509389, 5859908.11929196305573 ] } }, -{ "type": "Feature", "properties": { "level_0": 1387931.6147025716, "level_1": 5866170.5421204576, "height": null, "width": null, "bedlev": null, "branchid": "pipe_45_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_45", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": 0.5, "index_right": 878, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "where": "upstream", "distance_right": 6.266084733821659e-07, "nodeid": "1387931.614703_5866170.542120" }, "geometry": { "type": "Point", "coordinates": [ 1387931.614702571649104, 5866170.542120457626879 ] } }, -{ "type": "Feature", "properties": { "level_0": 1387940.4436740221, "level_1": 5865845.0932547273, "height": null, "width": null, "bedlev": null, "branchid": "pipe_47_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 886, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "where": "upstream", "distance_right": 2.7377250423463006e-07, "nodeid": "1387940.443674_5865845.093255" }, "geometry": { "type": "Point", "coordinates": [ 1387940.443674022099003, 5865845.093254727311432 ] } }, -{ "type": "Feature", "properties": { "level_0": 1392926.9667947688, "level_1": 5866808.5014050379, "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E125", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 893, "elevtn_up": 909.5, "elevtn_dn": 910.4000244140625, "invlev_up": 907.0, "invlev_dn": 907.9000244140625, "where": "upstream", "distance_right": 2.3433279429140186e-07, "nodeid": "1392926.966795_5866808.501405" }, "geometry": { "type": "Point", "coordinates": [ 1392926.966794768813998, 5866808.501405037939548 ] } } +{ "type": "Feature", "properties": { "level_0": 1383191.056227589, "level_1": 5854440.8114257297, "height": 17.349960327148438, "bedlev": 701.4000244140625, "width": 60.93007025, "branchid": "river_5", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_5", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": 6, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "where": "downstream", "distance_right": 4.9175380812341708e-07, "nodeid": "1383191.056228_5854440.811426" }, "geometry": { "type": "Point", "coordinates": [ 1383191.056227589026093, 5854440.811425729654729 ] } }, +{ "type": "Feature", "properties": { "level_0": 1393846.8667426864, "level_1": 5859166.3015384898, "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E140", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 168, "elevtn_up": 1144.300048828125, "elevtn_dn": 1112.5, "invlev_up": 1141.800048828125, "invlev_dn": 1110.0, "where": "downstream", "distance_right": 5.8166784782944824e-07, "nodeid": "1393846.866743_5859166.301538" }, "geometry": { "type": "Point", "coordinates": [ 1393846.866742686368525, 5859166.301538489758968 ] } }, +{ "type": "Feature", "properties": { "level_0": 1386078.4202513243, "level_1": 5859854.3928082353, "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1239", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 364, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "where": "downstream", "distance_right": 4.0088765079104887e-07, "nodeid": "1386078.420251_5859854.392808" }, "geometry": { "type": "Point", "coordinates": [ 1386078.420251324307173, 5859854.392808235250413 ] } }, +{ "type": "Feature", "properties": { "level_0": 1386045.2509392484, "level_1": 5859913.8590362957, "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E276", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 447, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "where": "downstream", "distance_right": 3.8584702415109949e-07, "nodeid": "1386045.250939_5859913.859036" }, "geometry": { "type": "Point", "coordinates": [ 1386045.250939248362556, 5859913.859036295674741 ] } }, +{ "type": "Feature", "properties": { "level_0": 1384484.1807617808, "level_1": 5857184.3018050948, "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E9", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 458, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "where": "downstream", "distance_right": 2.3880128290434959e-07, "nodeid": "1384484.180762_5857184.301805" }, "geometry": { "type": "Point", "coordinates": [ 1384484.18076178082265, 5857184.301805094815791 ] } }, +{ "type": "Feature", "properties": { "level_0": 1384480.7748306419, "level_1": 5857195.2444554009, "height": null, "bedlev": null, "width": null, "branchid": "pipe_15_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_15", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_15", "diameter": 0.5, "index_right": 467, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "where": "downstream", "distance_right": 5.3722077541611869e-07, "nodeid": "1384480.774831_5857195.244455" }, "geometry": { "type": "Point", "coordinates": [ 1384480.774830641923472, 5857195.244455400854349 ] } }, +{ "type": "Feature", "properties": { "level_0": 1385834.1594623995, "level_1": 5858793.8441787036, "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E47", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 519, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "where": "downstream", "distance_right": 4.9733410300668418e-07, "nodeid": "1385834.159462_5858793.844179" }, "geometry": { "type": "Point", "coordinates": [ 1385834.15946239954792, 5858793.844178703613579 ] } }, +{ "type": "Feature", "properties": { "level_0": 1385177.8775195002, "level_1": 5858363.9756671879, "height": null, "bedlev": null, "width": null, "branchid": "pipe_21_E4", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 525, "elevtn_up": 758.9000244140625, "elevtn_dn": 756.79998779296875, "invlev_up": 756.4000244140625, "invlev_dn": 754.29998779296875, "where": "downstream", "distance_right": 5.341153742051576e-07, "nodeid": "1385177.877520_5858363.975667" }, "geometry": { "type": "Point", "coordinates": [ 1385177.877519500209019, 5858363.975667187944055 ] } }, +{ "type": "Feature", "properties": { "level_0": 1384799.2182603152, "level_1": 5858488.5922634779, "height": null, "bedlev": null, "width": null, "branchid": "pipe_23_E1", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_23", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": 0.5, "index_right": 528, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "where": "downstream", "distance_right": 5.7240456036556167e-07, "nodeid": "1384799.218260_5858488.592263" }, "geometry": { "type": "Point", "coordinates": [ 1384799.21826031524688, 5858488.592263477854431 ] } }, +{ "type": "Feature", "properties": { "level_0": 1385472.2180530226, "level_1": 5858925.2730725091, "height": null, "bedlev": null, "width": null, "branchid": "pipe_25_E2", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_25", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": 0.5, "index_right": 535, "elevtn_up": 791.20001220703125, "elevtn_dn": 783.0, "invlev_up": 788.70001220703125, "invlev_dn": 780.5, "where": "downstream", "distance_right": 4.913263386404469e-07, "nodeid": "1385472.218053_5858925.273073" }, "geometry": { "type": "Point", "coordinates": [ 1385472.218053022632375, 5858925.273072509095073 ] } }, +{ "type": "Feature", "properties": { "level_0": 1388962.2407159139, "level_1": 5860301.717001454, "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E73", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 620, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "where": "downstream", "distance_right": 4.6166295054686266e-07, "nodeid": "1388962.240716_5860301.717001" }, "geometry": { "type": "Point", "coordinates": [ 1388962.240715913940221, 5860301.717001453973353 ] } }, +{ "type": "Feature", "properties": { "level_0": 1386273.1738117875, "level_1": 5859335.3654602878, "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E12", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 633, "elevtn_up": 717.60003662109375, "elevtn_dn": 711.0, "invlev_up": 715.10003662109375, "invlev_dn": 708.5, "where": "downstream", "distance_right": 3.577770704512787e-07, "nodeid": "1386273.173812_5859335.365460" }, "geometry": { "type": "Point", "coordinates": [ 1386273.173811787506565, 5859335.36546028777957 ] } }, +{ "type": "Feature", "properties": { "level_0": 1387692.1617963261, "level_1": 5866783.4206203762, "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E7", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 867, "elevtn_up": 816.10003662109375, "elevtn_dn": 802.4000244140625, "invlev_up": 813.60003662109375, "invlev_dn": 799.9000244140625, "where": "downstream", "distance_right": 4.9781434926194598e-07, "nodeid": "1387692.161796_5866783.420620" }, "geometry": { "type": "Point", "coordinates": [ 1387692.161796326050535, 5866783.420620376244187 ] } }, +{ "type": "Feature", "properties": { "level_0": 1387975.2799954726, "level_1": 5866107.4257222451, "height": null, "bedlev": null, "width": null, "branchid": "pipe_48_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_48", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_48", "diameter": 0.5, "index_right": 892, "elevtn_up": 803.9000244140625, "elevtn_dn": 786.29998779296875, "invlev_up": 801.4000244140625, "invlev_dn": 783.79998779296875, "where": "downstream", "distance_right": 5.3234291644079913e-07, "nodeid": "1387975.279995_5866107.425722" }, "geometry": { "type": "Point", "coordinates": [ 1387975.279995472636074, 5866107.425722245126963 ] } }, +{ "type": "Feature", "properties": { "level_0": 1394694.0702762168, "level_1": 5867648.108302163, "height": 22.5, "bedlev": 865.60003662109375, "width": 60.500781333333329, "branchid": "river_1", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_1", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": 0, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "where": "upstream", "distance_right": 2.7120132961912311e-07, "nodeid": "1394694.070276_5867648.108302" }, "geometry": { "type": "Point", "coordinates": [ 1394694.070276216836646, 5867648.108302162960172 ] } }, +{ "type": "Feature", "properties": { "level_0": 1386066.8097397459, "level_1": 5868052.7264932301, "height": 13.574996948242188, "bedlev": 813.29998779296875, "width": 63.595319, "branchid": "river_2", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_2", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": 2, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "where": "upstream", "distance_right": 3.4269831423038173e-07, "nodeid": "1386066.809740_5868052.726493" }, "geometry": { "type": "Point", "coordinates": [ 1386066.809739745920524, 5868052.726493230089545 ] } }, +{ "type": "Feature", "properties": { "level_0": 1391540.018037077, "level_1": 5858077.5772200329, "height": 21.70001220703125, "bedlev": 952.79998779296875, "width": 50.0, "branchid": "river_3", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_3", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": 3, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "where": "upstream", "distance_right": 8.367694927529332e-08, "nodeid": "1391540.018037_5858077.577220" }, "geometry": { "type": "Point", "coordinates": [ 1391540.01803707703948, 5858077.577220032922924 ] } }, +{ "type": "Feature", "properties": { "level_0": 1388521.2575925963, "level_1": 5855362.0276134778, "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1045", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 169, "elevtn_up": 968.29998779296875, "elevtn_dn": 968.29998779296875, "invlev_up": 965.79998779296875, "invlev_dn": 965.79998779296875, "where": "upstream", "distance_right": 6.2550722664998962e-07, "nodeid": "1388521.257593_5855362.027613" }, "geometry": { "type": "Point", "coordinates": [ 1388521.257592596346512, 5855362.027613477781415 ] } }, +{ "type": "Feature", "properties": { "level_0": 1384050.267680947, "level_1": 5856698.7020015484, "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E195", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 365, "elevtn_up": 814.29998779296875, "elevtn_dn": 802.9000244140625, "invlev_up": 811.79998779296875, "invlev_dn": 800.4000244140625, "where": "upstream", "distance_right": 4.5480020130277707e-07, "nodeid": "1384050.267681_5856698.702002" }, "geometry": { "type": "Point", "coordinates": [ 1384050.267680946970358, 5856698.702001548372209 ] } }, +{ "type": "Feature", "properties": { "level_0": 1384196.86181646, "level_1": 5856829.8804841097, "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 448, "elevtn_up": 800.79998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 798.29998779296875, "invlev_dn": 798.29998779296875, "where": "upstream", "distance_right": 4.7301652606593837e-07, "nodeid": "1384196.861816_5856829.880484" }, "geometry": { "type": "Point", "coordinates": [ 1384196.861816460033879, 5856829.88048410974443 ] } }, +{ "type": "Feature", "properties": { "level_0": 1384289.0655242952, "level_1": 5856954.9478410175, "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 459, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "where": "upstream", "distance_right": 2.9575907640532436e-07, "nodeid": "1384289.065524_5856954.947841" }, "geometry": { "type": "Point", "coordinates": [ 1384289.06552429520525, 5856954.947841017507017 ] } }, +{ "type": "Feature", "properties": { "level_0": 1384512.4849668304, "level_1": 5857248.8580293376, "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 471, "elevtn_up": 805.0, "elevtn_dn": 796.29998779296875, "invlev_up": 802.5, "invlev_dn": 793.79998779296875, "where": "upstream", "distance_right": 3.7745466738450301e-07, "nodeid": "1384512.484967_5857248.858029" }, "geometry": { "type": "Point", "coordinates": [ 1384512.484966830350459, 5857248.858029337599874 ] } }, +{ "type": "Feature", "properties": { "level_0": 1385352.4717880946, "level_1": 5858398.702550319, "height": null, "bedlev": null, "width": null, "branchid": "pipe_21_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 520, "elevtn_up": 756.29998779296875, "elevtn_dn": 765.0, "invlev_up": 753.79998779296875, "invlev_dn": 762.5, "where": "upstream", "distance_right": 3.3313663649888272e-07, "nodeid": "1385352.471788_5858398.702550" }, "geometry": { "type": "Point", "coordinates": [ 1385352.471788094611838, 5858398.70255031902343 ] } }, +{ "type": "Feature", "properties": { "level_0": 1384748.1072519517, "level_1": 5858475.4653943758, "height": null, "bedlev": null, "width": null, "branchid": "pipe_23_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_23", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": 0.5, "index_right": 526, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "where": "upstream", "distance_right": 3.7932856782999725e-07, "nodeid": "1384748.107252_5858475.465394" }, "geometry": { "type": "Point", "coordinates": [ 1384748.107251951703802, 5858475.46539437584579 ] } }, +{ "type": "Feature", "properties": { "level_0": 1385425.8717415037, "level_1": 5858809.5220389515, "height": null, "bedlev": null, "width": null, "branchid": "pipe_25_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_25", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": 0.5, "index_right": 532, "elevtn_up": 786.79998779296875, "elevtn_dn": 791.20001220703125, "invlev_up": 784.29998779296875, "invlev_dn": 788.70001220703125, "where": "upstream", "distance_right": 4.9875171671174047e-07, "nodeid": "1385425.871742_5858809.522039" }, "geometry": { "type": "Point", "coordinates": [ 1385425.871741503709927, 5858809.522038951516151 ] } }, +{ "type": "Feature", "properties": { "level_0": 1385861.3725137978, "level_1": 5858893.8325690301, "height": null, "bedlev": null, "width": null, "branchid": "pipe_29_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_29", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_29", "diameter": 0.5, "index_right": 536, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "where": "upstream", "distance_right": 2.0428258687376185e-07, "nodeid": "1385861.372514_5858893.832569" }, "geometry": { "type": "Point", "coordinates": [ 1385861.372513797832653, 5858893.832569030113518 ] } }, +{ "type": "Feature", "properties": { "level_0": 1387137.2230088995, "level_1": 5858981.7231069598, "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 538, "elevtn_up": 769.4000244140625, "elevtn_dn": 769.4000244140625, "invlev_up": 766.9000244140625, "invlev_dn": 766.9000244140625, "where": "upstream", "distance_right": 1.0826199317136784e-07, "nodeid": "1387137.223009_5858981.723107" }, "geometry": { "type": "Point", "coordinates": [ 1387137.22300889948383, 5858981.723106959834695 ] } }, +{ "type": "Feature", "properties": { "level_0": 1386030.9264584926, "level_1": 5859869.8815911002, "height": null, "bedlev": null, "width": null, "branchid": "pipe_36_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_36", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_36", "diameter": 0.5, "index_right": 726, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "where": "upstream", "distance_right": 5.0283226172582603e-07, "nodeid": "1386030.926458_5859869.881591" }, "geometry": { "type": "Point", "coordinates": [ 1386030.926458492642269, 5859869.881591100245714 ] } }, +{ "type": "Feature", "properties": { "level_0": 1386043.3811057615, "level_1": 5859908.1192919631, "height": null, "bedlev": null, "width": null, "branchid": "pipe_37_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_37", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_37", "diameter": 0.5, "index_right": 727, "elevtn_up": 766.29998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 778.29998779296875, "where": "upstream", "distance_right": 2.4131141216608354e-07, "nodeid": "1386043.381106_5859908.119292" }, "geometry": { "type": "Point", "coordinates": [ 1386043.381105761509389, 5859908.11929196305573 ] } }, +{ "type": "Feature", "properties": { "level_0": 1387931.6147025716, "level_1": 5866170.5421204576, "height": null, "bedlev": null, "width": null, "branchid": "pipe_45_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_45", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": 0.5, "index_right": 878, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "where": "upstream", "distance_right": 6.266084733821659e-07, "nodeid": "1387931.614703_5866170.542120" }, "geometry": { "type": "Point", "coordinates": [ 1387931.614702571649104, 5866170.542120457626879 ] } }, +{ "type": "Feature", "properties": { "level_0": 1387940.4436740221, "level_1": 5865845.0932547273, "height": null, "bedlev": null, "width": null, "branchid": "pipe_47_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 886, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "where": "upstream", "distance_right": 2.7377250423463006e-07, "nodeid": "1387940.443674_5865845.093255" }, "geometry": { "type": "Point", "coordinates": [ 1387940.443674022099003, 5865845.093254727311432 ] } }, +{ "type": "Feature", "properties": { "level_0": 1392926.9667947688, "level_1": 5866808.5014050379, "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E125", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 893, "elevtn_up": 909.5, "elevtn_dn": 910.4000244140625, "invlev_up": 907.0, "invlev_dn": 907.9000244140625, "where": "upstream", "distance_right": 2.3433279429140186e-07, "nodeid": "1392926.966795_5866808.501405" }, "geometry": { "type": "Point", "coordinates": [ 1392926.966794768813998, 5866808.501405037939548 ] } } ] } diff --git a/examples/dflowfm_piave/geoms/branches.geojson b/examples/dflowfm_piave/geoms/branches.geojson index 6f2e50ab..f94c09ba 100644 --- a/examples/dflowfm_piave/geoms/branches.geojson +++ b/examples/dflowfm_piave/geoms/branches.geojson @@ -2,1012 +2,1012 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::3857" } }, "features": [ -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_6_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_1_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389238.298387300921604, 5860147.714495398104191 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_6_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 933.5, "invlev_up": 913.4000244140625, "invlev_dn": 931.0, "manhole_up": "manhole_1_generated", "manhole_dn": "manhole_2_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389238.298387300921604, 5860147.714495398104191 ], [ 1389210.947846550960094, 5860184.343885350972414 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_6_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.5, "elevtn_dn": 933.5, "invlev_up": 931.0, "invlev_dn": 931.0, "manhole_up": "manhole_2_generated", "manhole_dn": "manhole_3_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389210.947846550960094, 5860184.343885350972414 ], [ 1389186.961922727525234, 5860223.315261371433735 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_6_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.5, "elevtn_dn": 935.5, "invlev_up": 931.0, "invlev_dn": 933.0, "manhole_up": "manhole_3_generated", "manhole_dn": "manhole_4_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389186.961922727525234, 5860223.315261371433735 ], [ 1389162.755598766496405, 5860262.142883376218379 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_6_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 935.5, "invlev_up": 933.0, "invlev_dn": 933.0, "manhole_up": "manhole_4_generated", "manhole_dn": "manhole_5_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389162.755598766496405, 5860262.142883376218379 ], [ 1389136.759307563304901, 5860299.80301527120173 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_6_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 936.5, "invlev_up": 933.0, "invlev_dn": 934.0, "manhole_up": "manhole_5_generated", "manhole_dn": "manhole_6_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389136.759307563304901, 5860299.80301527120173 ], [ 1389109.7301227634307, 5860336.652257356792688 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_6_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 936.5, "elevtn_dn": 941.10003662109375, "invlev_up": 934.0, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_6_generated", "manhole_dn": "manhole_7_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389109.7301227634307, 5860336.652257356792688 ], [ 1389073.18478828552179, 5860363.522737024351954 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_6_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_7_generated", "manhole_dn": "manhole_8_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389073.18478828552179, 5860363.522737024351954 ], [ 1389032.546542100608349, 5860384.329287325032055 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_6_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_8_generated", "manhole_dn": "manhole_9_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389032.546542100608349, 5860384.329287325032055 ], [ 1388989.578410296700895, 5860400.071978960186243 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_6_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 951.29998779296875, "invlev_up": 938.60003662109375, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_9_generated", "manhole_dn": "manhole_10_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388989.578410296700895, 5860400.071978960186243 ], [ 1388946.301100668497384, 5860414.883977899327874 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_7_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_11_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389221.905703959986567, 5860123.3256367566064 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_7_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_11_generated", "manhole_dn": "manhole_12_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389221.905703959986567, 5860123.3256367566064 ], [ 1389177.295895804418251, 5860134.962970778346062 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_7_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 919.60003662109375, "invlev_up": 913.4000244140625, "invlev_dn": 917.10003662109375, "manhole_up": "manhole_12_generated", "manhole_dn": "manhole_13_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389177.295895804418251, 5860134.962970778346062 ], [ 1389132.686087648617104, 5860146.600304800085723 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_7_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 919.60003662109375, "elevtn_dn": 919.60003662109375, "invlev_up": 917.10003662109375, "invlev_dn": 917.10003662109375, "manhole_up": "manhole_13_generated", "manhole_dn": "manhole_14_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389132.686087648617104, 5860146.600304800085723 ], [ 1389088.076279493048787, 5860158.237638821825385 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_7_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 919.60003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 917.10003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_14_generated", "manhole_dn": "manhole_15_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389088.076279493048787, 5860158.237638821825385 ], [ 1389044.226173994829878, 5860172.143308508209884 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_7_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 935.60003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_15_generated", "manhole_dn": "manhole_16_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389044.226173994829878, 5860172.143308508209884 ], [ 1389012.527182487538084, 5860198.239755615592003 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_7_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 935.60003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_16_generated", "manhole_dn": "manhole_17_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389012.527182487538084, 5860198.239755615592003 ], [ 1388995.773122631013393, 5860240.481283166445792 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_7_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 945.0, "invlev_up": 935.60003662109375, "invlev_dn": 942.5, "manhole_up": "manhole_17_generated", "manhole_dn": "manhole_18_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388995.773122631013393, 5860240.481283166445792 ], [ 1388973.630034049740061, 5860280.918223639950156 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_7_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.0, "elevtn_dn": 951.29998779296875, "invlev_up": 942.5, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_18_generated", "manhole_dn": "manhole_19_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388973.630034049740061, 5860280.918223639950156 ], [ 1388961.171157888136804, 5860324.081192856654525 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_7_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_19_generated", "manhole_dn": "manhole_20_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388961.171157888136804, 5860324.081192856654525 ], [ 1388955.410555170848966, 5860369.690168970264494 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_7_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_20_generated", "manhole_dn": "manhole_10_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388955.410555170848966, 5860369.690168970264494 ], [ 1388946.301100668497384, 5860414.883977899327874 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 914.5, "invlev_up": 913.4000244140625, "invlev_dn": 912.0, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_21_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389306.50000010849908, 5860083.476415127515793 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 914.5, "elevtn_dn": 914.5, "invlev_up": 912.0, "invlev_dn": 912.0, "manhole_up": "manhole_21_generated", "manhole_dn": "manhole_22_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389306.50000010849908, 5860083.476415127515793 ], [ 1389355.420758404070511, 5860074.630405306816101 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 914.5, "elevtn_dn": 929.9000244140625, "invlev_up": 912.0, "invlev_dn": 927.4000244140625, "manhole_up": "manhole_22_generated", "manhole_dn": "manhole_23_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389355.420758404070511, 5860074.630405306816101 ], [ 1389389.090761042200029, 5860042.4449307853356 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 929.9000244140625, "elevtn_dn": 955.0, "invlev_up": 927.4000244140625, "invlev_dn": 952.5, "manhole_up": "manhole_23_generated", "manhole_dn": "manhole_24_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389389.090761042200029, 5860042.4449307853356 ], [ 1389404.036260401364416, 5859994.775433851405978 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_24_generated", "manhole_dn": "manhole_25_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389404.036260401364416, 5859994.775433851405978 ], [ 1389418.744130451697856, 5859947.032028519548476 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_25_generated", "manhole_dn": "manhole_26_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389418.744130451697856, 5859947.032028519548476 ], [ 1389423.265342897269875, 5859897.853969652205706 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 975.29998779296875, "invlev_up": 952.5, "invlev_dn": 972.79998779296875, "manhole_up": "manhole_26_generated", "manhole_dn": "manhole_27_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389423.265342897269875, 5859897.853969652205706 ], [ 1389395.831073811277747, 5859856.743154510855675 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 975.29998779296875, "elevtn_dn": 963.0, "invlev_up": 972.79998779296875, "invlev_dn": 960.5, "manhole_up": "manhole_27_generated", "manhole_dn": "manhole_28_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389395.831073811277747, 5859856.743154510855675 ], [ 1389350.827042841585353, 5859839.640478814020753 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 963.0, "elevtn_dn": 963.0, "invlev_up": 960.5, "invlev_dn": 960.5, "manhole_up": "manhole_28_generated", "manhole_dn": "manhole_29_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389350.827042841585353, 5859839.640478814020753 ], [ 1389303.795788601972163, 5859855.887689013034105 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 963.0, "elevtn_dn": 945.4000244140625, "invlev_up": 960.5, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_29_generated", "manhole_dn": "manhole_30_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389303.795788601972163, 5859855.887689013034105 ], [ 1389256.284586790716276, 5859863.631580747663975 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 945.4000244140625, "invlev_up": 942.9000244140625, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_30_generated", "manhole_dn": "manhole_31_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389256.284586790716276, 5859863.631580747663975 ], [ 1389227.308454349869862, 5859823.781623384915292 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 945.4000244140625, "invlev_up": 942.9000244140625, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_31_generated", "manhole_dn": "manhole_32_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389227.308454349869862, 5859823.781623384915292 ], [ 1389202.745489193825051, 5859780.279727600514889 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 959.10003662109375, "invlev_up": 942.9000244140625, "invlev_dn": 956.60003662109375, "manhole_up": "manhole_32_generated", "manhole_dn": "manhole_33_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389202.745489193825051, 5859780.279727600514889 ], [ 1389178.18252403778024, 5859736.777831817045808 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 959.10003662109375, "elevtn_dn": 944.79998779296875, "invlev_up": 956.60003662109375, "invlev_dn": 942.29998779296875, "manhole_up": "manhole_33_generated", "manhole_dn": "manhole_34_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389178.18252403778024, 5859736.777831817045808 ], [ 1389155.231297271326184, 5859692.450142606161535 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 944.79998779296875, "elevtn_dn": 944.79998779296875, "invlev_up": 942.29998779296875, "invlev_dn": 942.29998779296875, "manhole_up": "manhole_34_generated", "manhole_dn": "manhole_35_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389155.231297271326184, 5859692.450142606161535 ], [ 1389141.413412723457441, 5859644.883844587020576 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 944.79998779296875, "elevtn_dn": 952.4000244140625, "invlev_up": 942.29998779296875, "invlev_dn": 949.9000244140625, "manhole_up": "manhole_35_generated", "manhole_dn": "manhole_36_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389141.413412723457441, 5859644.883844587020576 ], [ 1389151.802280035568401, 5859598.61804121825844 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.4000244140625, "elevtn_dn": 960.70001220703125, "invlev_up": 949.9000244140625, "invlev_dn": 958.20001220703125, "manhole_up": "manhole_36_generated", "manhole_dn": "manhole_37_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389151.802280035568401, 5859598.61804121825844 ], [ 1389191.073854762827978, 5859569.046822287142277 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 960.70001220703125, "elevtn_dn": 960.70001220703125, "invlev_up": 958.20001220703125, "invlev_dn": 958.20001220703125, "manhole_up": "manhole_37_generated", "manhole_dn": "manhole_38_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389191.073854762827978, 5859569.046822287142277 ], [ 1389239.915165816899389, 5859563.955490378662944 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 960.70001220703125, "elevtn_dn": 969.60003662109375, "invlev_up": 958.20001220703125, "invlev_dn": 967.10003662109375, "manhole_up": "manhole_38_generated", "manhole_dn": "manhole_39_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389239.915165816899389, 5859563.955490378662944 ], [ 1389289.757686472963542, 5859566.285022127442062 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 969.60003662109375, "elevtn_dn": 969.60003662109375, "invlev_up": 967.10003662109375, "invlev_dn": 967.10003662109375, "manhole_up": "manhole_39_generated", "manhole_dn": "manhole_40_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389289.757686472963542, 5859566.285022127442062 ], [ 1389339.615828452631831, 5859566.079234052449465 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 969.60003662109375, "elevtn_dn": 976.29998779296875, "invlev_up": 967.10003662109375, "invlev_dn": 973.79998779296875, "manhole_up": "manhole_40_generated", "manhole_dn": "manhole_41_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389339.615828452631831, 5859566.079234052449465 ], [ 1389387.354307833593339, 5859551.676988741382957 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 976.29998779296875, "elevtn_dn": 976.29998779296875, "invlev_up": 973.79998779296875, "invlev_dn": 973.79998779296875, "manhole_up": "manhole_41_generated", "manhole_dn": "manhole_42_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389387.354307833593339, 5859551.676988741382957 ], [ 1389428.692968821851537, 5859524.248876142315567 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 976.29998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 973.79998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_42_generated", "manhole_dn": "manhole_43_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389428.692968821851537, 5859524.248876142315567 ], [ 1389461.138921525795013, 5859486.477508954703808 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_43_generated", "manhole_dn": "manhole_44_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389461.138921525795013, 5859486.477508954703808 ], [ 1389482.45163832209073, 5859441.487986368127167 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_44_generated", "manhole_dn": "manhole_45_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389482.45163832209073, 5859441.487986368127167 ], [ 1389497.215460168197751, 5859393.906833835877478 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_45_generated", "manhole_dn": "manhole_46_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389497.215460168197751, 5859393.906833835877478 ], [ 1389508.394423164660111, 5859345.216126504354179 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 954.79998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_46_generated", "manhole_dn": "manhole_47_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389508.394423164660111, 5859345.216126504354179 ], [ 1389518.522437864448875, 5859296.29671473056078 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 954.79998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_47_generated", "manhole_dn": "manhole_48_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389518.522437864448875, 5859296.29671473056078 ], [ 1389528.588071504374966, 5859247.363727764226496 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 950.20001220703125, "invlev_up": 954.79998779296875, "invlev_dn": 947.70001220703125, "manhole_up": "manhole_48_generated", "manhole_dn": "manhole_49_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389528.588071504374966, 5859247.363727764226496 ], [ 1389538.653705144301057, 5859198.43074079696089 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 950.20001220703125, "elevtn_dn": 957.60003662109375, "invlev_up": 947.70001220703125, "invlev_dn": 955.10003662109375, "manhole_up": "manhole_49_generated", "manhole_dn": "manhole_50_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389538.653705144301057, 5859198.43074079696089 ], [ 1389548.719338784459978, 5859149.497753830626607 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.60003662109375, "elevtn_dn": 957.60003662109375, "invlev_up": 955.10003662109375, "invlev_dn": 955.10003662109375, "manhole_up": "manhole_50_generated", "manhole_dn": "manhole_51_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389548.719338784459978, 5859149.497753830626607 ], [ 1389558.784972424386069, 5859100.564766863361001 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.60003662109375, "elevtn_dn": 954.79998779296875, "invlev_up": 955.10003662109375, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_51_generated", "manhole_dn": "manhole_52_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389558.784972424386069, 5859100.564766863361001 ], [ 1389568.85060606431216, 5859051.631779897026718 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 954.79998779296875, "invlev_up": 952.29998779296875, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_52_generated", "manhole_dn": "manhole_53_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389568.85060606431216, 5859051.631779897026718 ], [ 1389578.916239704471081, 5859002.698792929761112 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 954.79998779296875, "invlev_up": 952.29998779296875, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_53_generated", "manhole_dn": "manhole_54_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389578.916239704471081, 5859002.698792929761112 ], [ 1389588.981873344397172, 5858953.765805963426828 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 956.10003662109375, "invlev_up": 952.29998779296875, "invlev_dn": 953.60003662109375, "manhole_up": "manhole_54_generated", "manhole_dn": "manhole_55_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389588.981873344397172, 5858953.765805963426828 ], [ 1389599.047506984323263, 5858904.832818996161222 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 956.10003662109375, "elevtn_dn": 956.10003662109375, "invlev_up": 953.60003662109375, "invlev_dn": 953.60003662109375, "manhole_up": "manhole_55_generated", "manhole_dn": "manhole_56_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389599.047506984323263, 5858904.832818996161222 ], [ 1389613.243873829254881, 5858857.048414096236229 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 956.10003662109375, "elevtn_dn": 966.29998779296875, "invlev_up": 953.60003662109375, "invlev_dn": 963.79998779296875, "manhole_up": "manhole_56_generated", "manhole_dn": "manhole_57_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389613.243873829254881, 5858857.048414096236229 ], [ 1389631.198101107496768, 5858810.554778259247541 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 966.29998779296875, "elevtn_dn": 968.70001220703125, "invlev_up": 963.79998779296875, "invlev_dn": 966.20001220703125, "manhole_up": "manhole_57_generated", "manhole_dn": "manhole_58_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389631.198101107496768, 5858810.554778259247541 ], [ 1389656.490605737781152, 5858767.472956065088511 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.70001220703125, "elevtn_dn": 968.70001220703125, "invlev_up": 966.20001220703125, "invlev_dn": 966.20001220703125, "manhole_up": "manhole_58_generated", "manhole_dn": "manhole_59_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389656.490605737781152, 5858767.472956065088511 ], [ 1389681.956975018838421, 5858724.49639992788434 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.70001220703125, "elevtn_dn": 976.10003662109375, "invlev_up": 966.20001220703125, "invlev_dn": 973.60003662109375, "manhole_up": "manhole_59_generated", "manhole_dn": "manhole_60_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389681.956975018838421, 5858724.49639992788434 ], [ 1389708.407580326776952, 5858682.115747822448611 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 976.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 973.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_60_generated", "manhole_dn": "manhole_61_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389708.407580326776952, 5858682.115747822448611 ], [ 1389734.858185634715483, 5858639.735095717012882 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 980.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_61_generated", "manhole_dn": "manhole_62_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389734.858185634715483, 5858639.735095717012882 ], [ 1389761.308790942654014, 5858597.354443610645831 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 980.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_62_generated", "manhole_dn": "manhole_63_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389761.308790942654014, 5858597.354443610645831 ], [ 1389787.759396250825375, 5858554.973791505210102 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 993.29998779296875, "invlev_up": 980.60003662109375, "invlev_dn": 990.79998779296875, "manhole_up": "manhole_63_generated", "manhole_dn": "manhole_64_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389787.759396250825375, 5858554.973791505210102 ], [ 1389814.210001558763906, 5858512.593139399774373 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 993.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 990.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_64_generated", "manhole_dn": "manhole_65_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389814.210001558763906, 5858512.593139399774373 ], [ 1389840.660606866702437, 5858470.212487293407321 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 995.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_65_generated", "manhole_dn": "manhole_66_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389840.660606866702437, 5858470.212487293407321 ], [ 1389867.111212174640968, 5858427.831835187971592 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 995.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_66_generated", "manhole_dn": "manhole_67_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389867.111212174640968, 5858427.831835187971592 ], [ 1389911.240854029776528, 5858417.074701879173517 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 1006.2000122070312, "invlev_up": 995.79998779296875, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_67_generated", "manhole_dn": "manhole_68_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389911.240854029776528, 5858417.074701879173517 ], [ 1389940.226093058940023, 5858455.739661679603159 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E48", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1006.2000122070312, "invlev_up": 1003.7000122070312, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_68_generated", "manhole_dn": "manhole_69_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389940.226093058940023, 5858455.739661679603159 ], [ 1389959.842267287895083, 5858501.684845351614058 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E49", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1006.2000122070312, "invlev_up": 1003.7000122070312, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_69_generated", "manhole_dn": "manhole_70_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389959.842267287895083, 5858501.684845351614058 ], [ 1389983.028926897095516, 5858544.760824581608176 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E50", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1036.9000244140625, "invlev_up": 1003.7000122070312, "invlev_dn": 1034.4000244140625, "manhole_up": "manhole_70_generated", "manhole_dn": "manhole_71_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389983.028926897095516, 5858544.760824581608176 ], [ 1390026.879799408372492, 5858567.986969069577754 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E51", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1036.9000244140625, "elevtn_dn": 1036.9000244140625, "invlev_up": 1034.4000244140625, "invlev_dn": 1034.4000244140625, "manhole_up": "manhole_71_generated", "manhole_dn": "manhole_72_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390026.879799408372492, 5858567.986969069577754 ], [ 1390075.455719914287329, 5858577.981817713007331 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E52", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1036.9000244140625, "elevtn_dn": 1032.9000244140625, "invlev_up": 1034.4000244140625, "invlev_dn": 1030.4000244140625, "manhole_up": "manhole_72_generated", "manhole_dn": "manhole_73_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390075.455719914287329, 5858577.981817713007331 ], [ 1390124.934819511603564, 5858584.860858413390815 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E53", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1032.9000244140625, "elevtn_dn": 1032.9000244140625, "invlev_up": 1030.4000244140625, "invlev_dn": 1030.4000244140625, "manhole_up": "manhole_73_generated", "manhole_dn": "manhole_74_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390124.934819511603564, 5858584.860858413390815 ], [ 1390174.385966305155307, 5858591.894069475121796 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E54", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1032.9000244140625, "elevtn_dn": 1016.6000366210938, "invlev_up": 1030.4000244140625, "invlev_dn": 1014.1000366210938, "manhole_up": "manhole_74_generated", "manhole_dn": "manhole_75_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390174.385966305155307, 5858591.894069475121796 ], [ 1390224.28731826832518, 5858594.262458441779017 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E55", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1016.6000366210938, "elevtn_dn": 1016.6000366210938, "invlev_up": 1014.1000366210938, "invlev_dn": 1014.1000366210938, "manhole_up": "manhole_75_generated", "manhole_dn": "manhole_76_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390224.28731826832518, 5858594.262458441779017 ], [ 1390273.630285855382681, 5858589.561945637688041 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E56", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1016.6000366210938, "elevtn_dn": 1012.1000366210938, "invlev_up": 1014.1000366210938, "invlev_dn": 1009.6000366210938, "manhole_up": "manhole_76_generated", "manhole_dn": "manhole_77_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390273.630285855382681, 5858589.561945637688041 ], [ 1390322.239480242831632, 5858578.072306710295379 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E57", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1012.1000366210938, "elevtn_dn": 1012.1000366210938, "invlev_up": 1009.6000366210938, "invlev_dn": 1009.6000366210938, "manhole_up": "manhole_77_generated", "manhole_dn": "manhole_78_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390322.239480242831632, 5858578.072306710295379 ], [ 1390371.99352877959609, 5858575.309522898867726 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E58", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1012.1000366210938, "elevtn_dn": 1011.7000122070312, "invlev_up": 1009.6000366210938, "invlev_dn": 1009.2000122070312, "manhole_up": "manhole_78_generated", "manhole_dn": "manhole_79_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390371.99352877959609, 5858575.309522898867726 ], [ 1390419.13544210139662, 5858559.59311543405056 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E59", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1011.7000122070312, "elevtn_dn": 981.5, "invlev_up": 1009.2000122070312, "invlev_dn": 979.0, "manhole_up": "manhole_79_generated", "manhole_dn": "manhole_80_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390419.13544210139662, 5858559.59311543405056 ], [ 1390453.401623640675098, 5858524.246223840862513 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E60", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 981.5, "elevtn_dn": 995.70001220703125, "invlev_up": 979.0, "invlev_dn": 993.20001220703125, "manhole_up": "manhole_80_generated", "manhole_dn": "manhole_81_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390453.401623640675098, 5858524.246223840862513 ], [ 1390496.749499944737181, 5858504.780008735135198 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E61", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 995.70001220703125, "elevtn_dn": 995.70001220703125, "invlev_up": 993.20001220703125, "invlev_dn": 993.20001220703125, "manhole_up": "manhole_81_generated", "manhole_dn": "manhole_82_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390496.749499944737181, 5858504.780008735135198 ], [ 1390546.470755147282034, 5858499.993151630274951 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E62", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 995.70001220703125, "elevtn_dn": 1005.9000244140625, "invlev_up": 993.20001220703125, "invlev_dn": 1003.4000244140625, "manhole_up": "manhole_82_generated", "manhole_dn": "manhole_83_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390546.470755147282034, 5858499.993151630274951 ], [ 1390596.395264241611585, 5858498.177226040512323 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E63", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1005.9000244140625, "elevtn_dn": 1005.9000244140625, "invlev_up": 1003.4000244140625, "invlev_dn": 1003.4000244140625, "manhole_up": "manhole_83_generated", "manhole_dn": "manhole_84_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390596.395264241611585, 5858498.177226040512323 ], [ 1390646.319773336173967, 5858496.361300451681018 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E64", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1005.9000244140625, "elevtn_dn": 1013.6000366210938, "invlev_up": 1003.4000244140625, "invlev_dn": 1011.1000366210938, "manhole_up": "manhole_84_generated", "manhole_dn": "manhole_85_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390646.319773336173967, 5858496.361300451681018 ], [ 1390696.244282430503517, 5858494.545374862849712 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E65", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1013.6000366210938, "elevtn_dn": 1013.6000366210938, "invlev_up": 1011.1000366210938, "invlev_dn": 1011.1000366210938, "manhole_up": "manhole_85_generated", "manhole_dn": "manhole_86_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390696.244282430503517, 5858494.545374862849712 ], [ 1390746.168791524833068, 5858492.729449273087084 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E66", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1013.6000366210938, "elevtn_dn": 1019.1000366210938, "invlev_up": 1011.1000366210938, "invlev_dn": 1016.6000366210938, "manhole_up": "manhole_86_generated", "manhole_dn": "manhole_87_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390746.168791524833068, 5858492.729449273087084 ], [ 1390796.09330061939545, 5858490.913523684255779 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E67", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1019.1000366210938, "elevtn_dn": 1025.800048828125, "invlev_up": 1016.6000366210938, "invlev_dn": 1023.300048828125, "manhole_up": "manhole_87_generated", "manhole_dn": "manhole_88_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390796.09330061939545, 5858490.913523684255779 ], [ 1390846.017809713725001, 5858489.097598095424473 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E68", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1025.800048828125, "elevtn_dn": 1025.800048828125, "invlev_up": 1023.300048828125, "invlev_dn": 1023.300048828125, "manhole_up": "manhole_88_generated", "manhole_dn": "manhole_89_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390846.017809713725001, 5858489.097598095424473 ], [ 1390895.942318808054551, 5858487.281672505661845 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E69", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1025.800048828125, "elevtn_dn": 1029.2000732421875, "invlev_up": 1023.300048828125, "invlev_dn": 1026.7000732421875, "manhole_up": "manhole_89_generated", "manhole_dn": "manhole_90_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390895.942318808054551, 5858487.281672505661845 ], [ 1390945.364988021552563, 5858492.061225635930896 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E70", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1029.2000732421875, "elevtn_dn": 1029.2000732421875, "invlev_up": 1026.7000732421875, "invlev_dn": 1026.7000732421875, "manhole_up": "manhole_90_generated", "manhole_dn": "manhole_91_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390945.364988021552563, 5858492.061225635930896 ], [ 1390994.440001817885786, 5858501.409873396158218 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E71", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1029.2000732421875, "elevtn_dn": 1033.2000732421875, "invlev_up": 1026.7000732421875, "invlev_dn": 1030.7000732421875, "manhole_up": "manhole_91_generated", "manhole_dn": "manhole_92_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390994.440001817885786, 5858501.409873396158218 ], [ 1391040.341196772176772, 5858520.979841153137386 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E72", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1033.2000732421875, "elevtn_dn": 1033.2000732421875, "invlev_up": 1030.7000732421875, "invlev_dn": 1030.7000732421875, "manhole_up": "manhole_92_generated", "manhole_dn": "manhole_93_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391040.341196772176772, 5858520.979841153137386 ], [ 1391086.683747049886733, 5858538.717575071379542 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E73", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1033.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1030.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_93_generated", "manhole_dn": "manhole_94_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391086.683747049886733, 5858538.717575071379542 ], [ 1391131.822940095094964, 5858523.93243224080652 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E74", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_94_generated", "manhole_dn": "manhole_95_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391131.822940095094964, 5858523.93243224080652 ], [ 1391153.157672074623406, 5858479.460670891217887 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E75", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_95_generated", "manhole_dn": "manhole_96_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391153.157672074623406, 5858479.460670891217887 ], [ 1391192.49590603238903, 5858451.67839205916971 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E76", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1044.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1041.7000732421875, "manhole_up": "manhole_96_generated", "manhole_dn": "manhole_97_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391192.49590603238903, 5858451.67839205916971 ], [ 1391240.64117361814715, 5858438.460245226509869 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E77", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1044.2000732421875, "elevtn_dn": 1044.2000732421875, "invlev_up": 1041.7000732421875, "invlev_dn": 1041.7000732421875, "manhole_up": "manhole_97_generated", "manhole_dn": "manhole_98_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391240.64117361814715, 5858438.460245226509869 ], [ 1391289.211760010803118, 5858426.770406410098076 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E78", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1044.2000732421875, "elevtn_dn": 1060.0999755859375, "invlev_up": 1041.7000732421875, "invlev_dn": 1057.5999755859375, "manhole_up": "manhole_98_generated", "manhole_dn": "manhole_99_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391289.211760010803118, 5858426.770406410098076 ], [ 1391337.782346403226256, 5858415.080567593686283 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E79", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1060.0999755859375, "elevtn_dn": 1023.0, "invlev_up": 1057.5999755859375, "invlev_dn": 1020.5, "manhole_up": "manhole_99_generated", "manhole_dn": "manhole_100_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391337.782346403226256, 5858415.080567593686283 ], [ 1391386.352932795882225, 5858403.390728777274489 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E80", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1023.0, "elevtn_dn": 1032.7000732421875, "invlev_up": 1020.5, "invlev_dn": 1030.2000732421875, "manhole_up": "manhole_100_generated", "manhole_dn": "manhole_101_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391386.352932795882225, 5858403.390728777274489 ], [ 1391434.923519188305363, 5858391.700889961794019 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E81", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1032.7000732421875, "elevtn_dn": 1032.7000732421875, "invlev_up": 1030.2000732421875, "invlev_dn": 1030.2000732421875, "manhole_up": "manhole_101_generated", "manhole_dn": "manhole_102_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391434.923519188305363, 5858391.700889961794019 ], [ 1391483.494105580961332, 5858380.011051145382226 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E82", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1032.7000732421875, "elevtn_dn": 1040.7000732421875, "invlev_up": 1030.2000732421875, "invlev_dn": 1038.2000732421875, "manhole_up": "manhole_102_generated", "manhole_dn": "manhole_103_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391483.494105580961332, 5858380.011051145382226 ], [ 1391532.464345134794712, 5858375.802092345431447 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E83", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1040.7000732421875, "elevtn_dn": 1040.7000732421875, "invlev_up": 1038.2000732421875, "invlev_dn": 1038.2000732421875, "manhole_up": "manhole_103_generated", "manhole_dn": "manhole_104_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391532.464345134794712, 5858375.802092345431447 ], [ 1391579.680508555145934, 5858389.753166117705405 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E84", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1040.7000732421875, "elevtn_dn": 1094.5999755859375, "invlev_up": 1038.2000732421875, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_104_generated", "manhole_dn": "manhole_105_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391579.680508555145934, 5858389.753166117705405 ], [ 1391615.043221722124144, 5858422.374543751589954 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E85", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1094.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_105_generated", "manhole_dn": "manhole_106_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391615.043221722124144, 5858422.374543751589954 ], [ 1391633.654095822479576, 5858468.206737855449319 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E86", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1094.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_106_generated", "manhole_dn": "manhole_107_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391633.654095822479576, 5858468.206737855449319 ], [ 1391675.556871910346672, 5858492.042518986389041 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E87", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1100.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1098.0999755859375, "manhole_up": "manhole_107_generated", "manhole_dn": "manhole_108_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391675.556871910346672, 5858492.042518986389041 ], [ 1391725.165284683462232, 5858493.223410680890083 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E88", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1100.5999755859375, "elevtn_dn": 1092.7000732421875, "invlev_up": 1098.0999755859375, "invlev_dn": 1090.2000732421875, "manhole_up": "manhole_108_generated", "manhole_dn": "manhole_109_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391725.165284683462232, 5858493.223410680890083 ], [ 1391774.025632579578087, 5858482.968163449317217 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E89", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1092.7000732421875, "elevtn_dn": 1092.7000732421875, "invlev_up": 1090.2000732421875, "invlev_dn": 1090.2000732421875, "manhole_up": "manhole_109_generated", "manhole_dn": "manhole_110_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391774.025632579578087, 5858482.968163449317217 ], [ 1391822.748904443578795, 5858472.800456050783396 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E90", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1092.7000732421875, "elevtn_dn": 1086.5, "invlev_up": 1090.2000732421875, "invlev_dn": 1084.0, "manhole_up": "manhole_110_generated", "manhole_dn": "manhole_111_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391822.748904443578795, 5858472.800456050783396 ], [ 1391872.520155652426183, 5858474.254766616038978 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E91", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1086.5, "elevtn_dn": 1086.5, "invlev_up": 1084.0, "invlev_dn": 1084.0, "manhole_up": "manhole_111_generated", "manhole_dn": "manhole_112_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391872.520155652426183, 5858474.254766616038978 ], [ 1391922.32820742437616, 5858478.116394865326583 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E92", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1086.5, "elevtn_dn": 1097.300048828125, "invlev_up": 1084.0, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_112_generated", "manhole_dn": "manhole_113_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391922.32820742437616, 5858478.116394865326583 ], [ 1391972.136259196558967, 5858481.978023114614189 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E93", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_113_generated", "manhole_dn": "manhole_114_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391972.136259196558967, 5858481.978023114614189 ], [ 1392014.088137687649578, 5858507.265420926734805 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E94", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_114_generated", "manhole_dn": "manhole_115_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392014.088137687649578, 5858507.265420926734805 ], [ 1392052.00577615830116, 5858538.949620860628784 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E95", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_115_generated", "manhole_dn": "manhole_116_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392052.00577615830116, 5858538.949620860628784 ], [ 1392100.993319420609623, 5858548.746293722651899 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E96", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1135.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1132.800048828125, "manhole_up": "manhole_116_generated", "manhole_dn": "manhole_117_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392100.993319420609623, 5858548.746293722651899 ], [ 1392149.980862683150917, 5858558.542966585606337 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E97", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1135.300048828125, "elevtn_dn": 1135.300048828125, "invlev_up": 1132.800048828125, "invlev_dn": 1132.800048828125, "manhole_up": "manhole_117_generated", "manhole_dn": "manhole_118_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392149.980862683150917, 5858558.542966585606337 ], [ 1392198.767287699971348, 5858569.25206732749939 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E98", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1135.300048828125, "elevtn_dn": 1137.5999755859375, "invlev_up": 1132.800048828125, "invlev_dn": 1135.0999755859375, "manhole_up": "manhole_118_generated", "manhole_dn": "manhole_119_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392198.767287699971348, 5858569.25206732749939 ], [ 1392247.333906656363979, 5858580.958378325216472 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E99", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1137.5999755859375, "elevtn_dn": 1137.5999755859375, "invlev_up": 1135.0999755859375, "invlev_dn": 1135.0999755859375, "manhole_up": "manhole_119_generated", "manhole_dn": "manhole_120_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392247.333906656363979, 5858580.958378325216472 ], [ 1392295.900525612989441, 5858592.664689323864877 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E100", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1137.5999755859375, "elevtn_dn": 1145.0999755859375, "invlev_up": 1135.0999755859375, "invlev_dn": 1142.5999755859375, "manhole_up": "manhole_120_generated", "manhole_dn": "manhole_121_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392295.900525612989441, 5858592.664689323864877 ], [ 1392344.467144569614902, 5858604.371000322513282 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E101", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1145.0999755859375, "elevtn_dn": 1145.0999755859375, "invlev_up": 1142.5999755859375, "invlev_dn": 1142.5999755859375, "manhole_up": "manhole_121_generated", "manhole_dn": "manhole_122_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392344.467144569614902, 5858604.371000322513282 ], [ 1392389.908255772199482, 5858624.575613909401 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E102", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1145.0999755859375, "elevtn_dn": 1140.5, "invlev_up": 1142.5999755859375, "invlev_dn": 1138.0, "manhole_up": "manhole_122_generated", "manhole_dn": "manhole_123_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392389.908255772199482, 5858624.575613909401 ], [ 1392425.081700494978577, 5858659.315580372698605 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E103", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1140.5, "elevtn_dn": 1169.300048828125, "invlev_up": 1138.0, "invlev_dn": 1166.800048828125, "manhole_up": "manhole_123_generated", "manhole_dn": "manhole_124_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392425.081700494978577, 5858659.315580372698605 ], [ 1392458.203119478421286, 5858696.715123130939901 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E104", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.300048828125, "elevtn_dn": 1169.300048828125, "invlev_up": 1166.800048828125, "invlev_dn": 1166.800048828125, "manhole_up": "manhole_124_generated", "manhole_dn": "manhole_125_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392458.203119478421286, 5858696.715123130939901 ], [ 1392491.324538461863995, 5858734.114665890112519 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E105", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.300048828125, "elevtn_dn": 1165.5, "invlev_up": 1166.800048828125, "invlev_dn": 1163.0, "manhole_up": "manhole_125_generated", "manhole_dn": "manhole_126_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392491.324538461863995, 5858734.114665890112519 ], [ 1392528.963966277893633, 5858766.460637149401009 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E106", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1165.5, "elevtn_dn": 1165.5, "invlev_up": 1163.0, "invlev_dn": 1163.0, "manhole_up": "manhole_126_generated", "manhole_dn": "manhole_127_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392528.963966277893633, 5858766.460637149401009 ], [ 1392573.284122244687751, 5858789.391092935577035 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E107", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1165.5, "elevtn_dn": 1157.0999755859375, "invlev_up": 1163.0, "invlev_dn": 1154.5999755859375, "manhole_up": "manhole_127_generated", "manhole_dn": "manhole_128_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392573.284122244687751, 5858789.391092935577035 ], [ 1392618.033192394766957, 5858811.600886153057218 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E108", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1157.0999755859375, "elevtn_dn": 1184.800048828125, "invlev_up": 1154.5999755859375, "invlev_dn": 1182.300048828125, "manhole_up": "manhole_128_generated", "manhole_dn": "manhole_129_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392618.033192394766957, 5858811.600886153057218 ], [ 1392666.730896146036685, 5858821.011833874508739 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E109", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1184.800048828125, "elevtn_dn": 1141.2000732421875, "invlev_up": 1182.300048828125, "invlev_dn": 1138.7000732421875, "manhole_up": "manhole_129_generated", "manhole_dn": "manhole_130_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392666.730896146036685, 5858821.011833874508739 ], [ 1392714.397227015113458, 5858809.184477739967406 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E110", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1141.2000732421875, "elevtn_dn": 1141.2000732421875, "invlev_up": 1138.7000732421875, "invlev_dn": 1138.7000732421875, "manhole_up": "manhole_130_generated", "manhole_dn": "manhole_131_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392714.397227015113458, 5858809.184477739967406 ], [ 1392761.799294820055366, 5858794.231293976306915 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E111", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1141.2000732421875, "elevtn_dn": 1137.4000244140625, "invlev_up": 1138.7000732421875, "invlev_dn": 1134.9000244140625, "manhole_up": "manhole_131_generated", "manhole_dn": "manhole_132_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392761.799294820055366, 5858794.231293976306915 ], [ 1392810.095712865469977, 5858797.830352782271802 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E112", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1137.4000244140625, "elevtn_dn": 1137.4000244140625, "invlev_up": 1134.9000244140625, "invlev_dn": 1134.9000244140625, "manhole_up": "manhole_132_generated", "manhole_dn": "manhole_133_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392810.095712865469977, 5858797.830352782271802 ], [ 1392855.660074200481176, 5858817.529770986177027 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E113", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1137.4000244140625, "elevtn_dn": 1169.5, "invlev_up": 1134.9000244140625, "invlev_dn": 1167.0, "manhole_up": "manhole_133_generated", "manhole_dn": "manhole_134_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392855.660074200481176, 5858817.529770986177027 ], [ 1392904.672455, 5858826.347064822912216 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E114", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_134_generated", "manhole_dn": "manhole_135_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392904.672455, 5858826.347064822912216 ], [ 1392949.505032581742853, 5858846.393358059227467 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E115", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_135_generated", "manhole_dn": "manhole_136_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392949.505032581742853, 5858846.393358059227467 ], [ 1392993.956312821945176, 5858868.358838438987732 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E116", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_136_generated", "manhole_dn": "manhole_137_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392993.956312821945176, 5858868.358838438987732 ], [ 1393042.160067020915449, 5858881.479519641026855 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E117", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1162.0, "invlev_up": 1167.0, "invlev_dn": 1159.5, "manhole_up": "manhole_137_generated", "manhole_dn": "manhole_138_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393042.160067020915449, 5858881.479519641026855 ], [ 1393090.363821219652891, 5858894.600200843065977 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E118", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1162.0, "elevtn_dn": 1162.0, "invlev_up": 1159.5, "invlev_dn": 1159.5, "manhole_up": "manhole_138_generated", "manhole_dn": "manhole_139_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393090.363821219652891, 5858894.600200843065977 ], [ 1393138.877780271228403, 5858905.382868006825447 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E119", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1162.0, "elevtn_dn": 1152.0999755859375, "invlev_up": 1159.5, "invlev_dn": 1149.5999755859375, "manhole_up": "manhole_139_generated", "manhole_dn": "manhole_140_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393138.877780271228403, 5858905.382868006825447 ], [ 1393188.835210436256602, 5858905.286093098111451 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E120", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1152.0999755859375, "elevtn_dn": 1152.0999755859375, "invlev_up": 1149.5999755859375, "invlev_dn": 1149.5999755859375, "manhole_up": "manhole_140_generated", "manhole_dn": "manhole_141_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393188.835210436256602, 5858905.286093098111451 ], [ 1393237.248238409170881, 5858916.599204055964947 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E121", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1152.0999755859375, "elevtn_dn": 1147.300048828125, "invlev_up": 1149.5999755859375, "invlev_dn": 1144.800048828125, "manhole_up": "manhole_141_generated", "manhole_dn": "manhole_142_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393237.248238409170881, 5858916.599204055964947 ], [ 1393278.15638761385344, 5858943.766047672368586 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E122", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1147.300048828125, "elevtn_dn": 1182.7000732421875, "invlev_up": 1144.800048828125, "invlev_dn": 1180.2000732421875, "manhole_up": "manhole_142_generated", "manhole_dn": "manhole_143_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393278.15638761385344, 5858943.766047672368586 ], [ 1393316.553906054003164, 5858975.725158606655896 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E123", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1182.7000732421875, "elevtn_dn": 1180.0999755859375, "invlev_up": 1180.2000732421875, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_143_generated", "manhole_dn": "manhole_144_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393316.553906054003164, 5858975.725158606655896 ], [ 1393354.951424494385719, 5859007.684269540011883 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E124", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1180.0999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_144_generated", "manhole_dn": "manhole_145_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393354.951424494385719, 5859007.684269540011883 ], [ 1393393.348942934535444, 5859039.643380474299192 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E125", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1180.0999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_145_generated", "manhole_dn": "manhole_146_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393393.348942934535444, 5859039.643380474299192 ], [ 1393431.746461374685168, 5859071.602491408586502 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E126", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_146_generated", "manhole_dn": "manhole_147_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393431.746461374685168, 5859071.602491408586502 ], [ 1393472.672340910183266, 5859100.089053857140243 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E127", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1200.0999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_147_generated", "manhole_dn": "manhole_148_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393472.672340910183266, 5859100.089053857140243 ], [ 1393507.678647378925234, 5859134.262682756409049 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E128", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1200.0999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_148_generated", "manhole_dn": "manhole_149_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393507.678647378925234, 5859134.262682756409049 ], [ 1393492.637579936999828, 5859179.667013085447252 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E129", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1232.300048828125, "invlev_up": 1200.0999755859375, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_149_generated", "manhole_dn": "manhole_150_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393492.637579936999828, 5859179.667013085447252 ], [ 1393472.727902054553851, 5859225.064155456610024 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E130", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_150_generated", "manhole_dn": "manhole_151_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393472.727902054553851, 5859225.064155456610024 ], [ 1393467.563765458529815, 5859274.587596206925809 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E131", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_151_generated", "manhole_dn": "manhole_152_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393467.563765458529815, 5859274.587596206925809 ], [ 1393473.51405850565061, 5859323.8850102070719 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E132", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_152_generated", "manhole_dn": "manhole_153_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393473.51405850565061, 5859323.8850102070719 ], [ 1393507.773820924572647, 5859356.614802500233054 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E133", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1214.800048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1212.300048828125, "manhole_up": "manhole_153_generated", "manhole_dn": "manhole_154_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393507.773820924572647, 5859356.614802500233054 ], [ 1393555.824224345618859, 5859349.253152369521558 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E134", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1214.800048828125, "elevtn_dn": 1214.800048828125, "invlev_up": 1212.300048828125, "invlev_dn": 1212.300048828125, "manhole_up": "manhole_154_generated", "manhole_dn": "manhole_155_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393555.824224345618859, 5859349.253152369521558 ], [ 1393591.00338595919311, 5859314.794959847815335 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E135", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1214.800048828125, "elevtn_dn": 1191.0999755859375, "invlev_up": 1212.300048828125, "invlev_dn": 1188.5999755859375, "manhole_up": "manhole_155_generated", "manhole_dn": "manhole_156_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393591.00338595919311, 5859314.794959847815335 ], [ 1393633.153639519121498, 5859288.066565420478582 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E136", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1191.0999755859375, "elevtn_dn": 1191.0999755859375, "invlev_up": 1188.5999755859375, "invlev_dn": 1188.5999755859375, "manhole_up": "manhole_156_generated", "manhole_dn": "manhole_157_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393633.153639519121498, 5859288.066565420478582 ], [ 1393673.123904188396409, 5859258.097712650895119 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E137", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1191.0999755859375, "elevtn_dn": 1144.300048828125, "invlev_up": 1188.5999755859375, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_157_generated", "manhole_dn": "manhole_158_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393673.123904188396409, 5859258.097712650895119 ], [ 1393720.523227575467899, 5859244.838272913359106 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E138", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1144.300048828125, "invlev_up": 1141.800048828125, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_158_generated", "manhole_dn": "manhole_159_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393720.523227575467899, 5859244.838272913359106 ], [ 1393765.710014625452459, 5859224.569284616038203 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E139", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1144.300048828125, "invlev_up": 1141.800048828125, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_159_generated", "manhole_dn": "manhole_160_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393765.710014625452459, 5859224.569284616038203 ], [ 1393806.409210936399177, 5859195.609256223775446 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E140", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1112.5, "invlev_up": 1141.800048828125, "invlev_dn": 1110.0, "manhole_up": "manhole_160_generated", "manhole_dn": "manhole_161_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393806.409210936399177, 5859195.609256223775446 ], [ 1393846.866742686368525, 5859166.301538489758968 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1045", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 968.29998779296875, "invlev_up": 965.79998779296875, "invlev_dn": 965.79998779296875, "manhole_up": "manhole_162_generated", "manhole_dn": "manhole_163_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388521.257592596346512, 5855362.027613477781415 ], [ 1388472.030306826578453, 5855370.543775821104646 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1046", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 968.29998779296875, "invlev_up": 965.79998779296875, "invlev_dn": 965.79998779296875, "manhole_up": "manhole_163_generated", "manhole_dn": "manhole_164_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388472.030306826578453, 5855370.543775821104646 ], [ 1388439.000347282737494, 5855407.802592809312046 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1047", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 964.5, "invlev_up": 965.79998779296875, "invlev_dn": 962.0, "manhole_up": "manhole_164_generated", "manhole_dn": "manhole_165_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388439.000347282737494, 5855407.802592809312046 ], [ 1388400.196091859601438, 5855436.014134516008198 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1048", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 964.5, "invlev_up": 962.0, "invlev_dn": 962.0, "manhole_up": "manhole_165_generated", "manhole_dn": "manhole_166_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388400.196091859601438, 5855436.014134516008198 ], [ 1388351.33823574683629, 5855446.634319253265858 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1049", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 981.9000244140625, "invlev_up": 962.0, "invlev_dn": 979.4000244140625, "manhole_up": "manhole_166_generated", "manhole_dn": "manhole_167_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388351.33823574683629, 5855446.634319253265858 ], [ 1388301.961881892289966, 5855453.847477887757123 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1050", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 981.9000244140625, "elevtn_dn": 981.9000244140625, "invlev_up": 979.4000244140625, "invlev_dn": 979.4000244140625, "manhole_up": "manhole_167_generated", "manhole_dn": "manhole_168_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388301.961881892289966, 5855453.847477887757123 ], [ 1388252.297577269142494, 5855451.260453455150127 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1051", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 981.9000244140625, "elevtn_dn": 973.70001220703125, "invlev_up": 979.4000244140625, "invlev_dn": 971.20001220703125, "manhole_up": "manhole_168_generated", "manhole_dn": "manhole_169_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388252.297577269142494, 5855451.260453455150127 ], [ 1388202.479659734526649, 5855455.508814659900963 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1052", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 973.70001220703125, "elevtn_dn": 961.70001220703125, "invlev_up": 971.20001220703125, "invlev_dn": 959.20001220703125, "manhole_up": "manhole_169_generated", "manhole_dn": "manhole_170_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388202.479659734526649, 5855455.508814659900963 ], [ 1388152.683455461403355, 5855460.015516467392445 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1053", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 961.70001220703125, "elevtn_dn": 961.70001220703125, "invlev_up": 959.20001220703125, "invlev_dn": 959.20001220703125, "manhole_up": "manhole_170_generated", "manhole_dn": "manhole_171_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388152.683455461403355, 5855460.015516467392445 ], [ 1388104.622611842118204, 5855473.253733876161277 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1054", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 961.70001220703125, "elevtn_dn": 945.79998779296875, "invlev_up": 959.20001220703125, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_171_generated", "manhole_dn": "manhole_172_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388104.622611842118204, 5855473.253733876161277 ], [ 1388057.00563437351957, 5855488.445189393125474 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1055", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 945.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_172_generated", "manhole_dn": "manhole_173_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388057.00563437351957, 5855488.445189393125474 ], [ 1388011.292356542311609, 5855508.700276436284184 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1056", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 945.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_173_generated", "manhole_dn": "manhole_174_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388011.292356542311609, 5855508.700276436284184 ], [ 1387969.221702651120722, 5855535.246164590120316 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1057", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 930.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 928.29998779296875, "manhole_up": "manhole_174_generated", "manhole_dn": "manhole_175_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.221702651120722, 5855535.246164590120316 ], [ 1387935.863196024205536, 5855572.491061648353934 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1058", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 930.79998779296875, "elevtn_dn": 957.10003662109375, "invlev_up": 928.29998779296875, "invlev_dn": 954.60003662109375, "manhole_up": "manhole_175_generated", "manhole_dn": "manhole_176_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387935.863196024205536, 5855572.491061648353934 ], [ 1387904.610231971368194, 5855611.432584651745856 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1059", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.10003662109375, "elevtn_dn": 947.4000244140625, "invlev_up": 954.60003662109375, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_176_generated", "manhole_dn": "manhole_177_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387904.610231971368194, 5855611.432584651745856 ], [ 1387869.335365027422085, 5855646.852918352000415 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1060", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 947.4000244140625, "invlev_up": 944.9000244140625, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_177_generated", "manhole_dn": "manhole_178_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387869.335365027422085, 5855646.852918352000415 ], [ 1387831.783288773847744, 5855679.735664095729589 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1061", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 947.4000244140625, "invlev_up": 944.9000244140625, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_178_generated", "manhole_dn": "manhole_179_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387831.783288773847744, 5855679.735664095729589 ], [ 1387791.509416193468496, 5855708.923279576934874 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1062", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 933.29998779296875, "invlev_up": 944.9000244140625, "invlev_dn": 930.79998779296875, "manhole_up": "manhole_179_generated", "manhole_dn": "manhole_180_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387791.509416193468496, 5855708.923279576934874 ], [ 1387742.459816947113723, 5855717.213657722808421 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1063", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.29998779296875, "elevtn_dn": 933.29998779296875, "invlev_up": 930.79998779296875, "invlev_dn": 930.79998779296875, "manhole_up": "manhole_180_generated", "manhole_dn": "manhole_181_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387742.459816947113723, 5855717.213657722808421 ], [ 1387692.500367184402421, 5855718.495403698645532 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1064", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.29998779296875, "elevtn_dn": 911.10003662109375, "invlev_up": 930.79998779296875, "invlev_dn": 908.60003662109375, "manhole_up": "manhole_181_generated", "manhole_dn": "manhole_182_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387692.500367184402421, 5855718.495403698645532 ], [ 1387642.500798417022452, 5855718.61967874225229 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1065", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.10003662109375, "elevtn_dn": 887.70001220703125, "invlev_up": 908.60003662109375, "invlev_dn": 885.20001220703125, "manhole_up": "manhole_182_generated", "manhole_dn": "manhole_183_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387642.500798417022452, 5855718.61967874225229 ], [ 1387592.501229649642482, 5855718.743953784927726 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1066", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 887.70001220703125, "elevtn_dn": 887.70001220703125, "invlev_up": 885.20001220703125, "invlev_dn": 885.20001220703125, "manhole_up": "manhole_183_generated", "manhole_dn": "manhole_184_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387592.501229649642482, 5855718.743953784927726 ], [ 1387542.501660882262513, 5855718.868228827603161 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1067", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 887.70001220703125, "elevtn_dn": 902.9000244140625, "invlev_up": 885.20001220703125, "invlev_dn": 900.4000244140625, "manhole_up": "manhole_184_generated", "manhole_dn": "manhole_185_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387542.501660882262513, 5855718.868228827603161 ], [ 1387492.651409652316943, 5855720.815255363471806 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1068", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 902.9000244140625, "elevtn_dn": 902.9000244140625, "invlev_up": 900.4000244140625, "invlev_dn": 900.4000244140625, "manhole_up": "manhole_185_generated", "manhole_dn": "manhole_186_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387492.651409652316943, 5855720.815255363471806 ], [ 1387448.867236748570576, 5855742.752516686916351 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1069", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 902.9000244140625, "elevtn_dn": 886.20001220703125, "invlev_up": 900.4000244140625, "invlev_dn": 883.70001220703125, "manhole_up": "manhole_186_generated", "manhole_dn": "manhole_187_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387448.867236748570576, 5855742.752516686916351 ], [ 1387402.432745414320379, 5855761.091833713464439 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1070", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 886.20001220703125, "elevtn_dn": 886.20001220703125, "invlev_up": 883.70001220703125, "invlev_dn": 883.70001220703125, "manhole_up": "manhole_187_generated", "manhole_dn": "manhole_188_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387402.432745414320379, 5855761.091833713464439 ], [ 1387355.687973388005048, 5855778.837216476909816 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1071", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 886.20001220703125, "elevtn_dn": 879.4000244140625, "invlev_up": 883.70001220703125, "invlev_dn": 876.9000244140625, "manhole_up": "manhole_188_generated", "manhole_dn": "manhole_189_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387355.687973388005048, 5855778.837216476909816 ], [ 1387308.943201361689717, 5855796.582599240355194 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1072", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 879.4000244140625, "elevtn_dn": 879.4000244140625, "invlev_up": 876.9000244140625, "invlev_dn": 876.9000244140625, "manhole_up": "manhole_189_generated", "manhole_dn": "manhole_190_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387308.943201361689717, 5855796.582599240355194 ], [ 1387262.861613623332232, 5855815.656713440082967 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1073", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 879.4000244140625, "elevtn_dn": 873.29998779296875, "invlev_up": 876.9000244140625, "invlev_dn": 870.79998779296875, "manhole_up": "manhole_190_generated", "manhole_dn": "manhole_191_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387262.861613623332232, 5855815.656713440082967 ], [ 1387224.059019178850576, 5855846.996291697025299 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1074", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 873.29998779296875, "elevtn_dn": 938.9000244140625, "invlev_up": 870.79998779296875, "invlev_dn": 936.4000244140625, "manhole_up": "manhole_191_generated", "manhole_dn": "manhole_192_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387224.059019178850576, 5855846.996291697025299 ], [ 1387180.719124856637791, 5855870.194651792757213 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1075", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 938.9000244140625, "elevtn_dn": 932.79998779296875, "invlev_up": 936.4000244140625, "invlev_dn": 930.29998779296875, "manhole_up": "manhole_192_generated", "manhole_dn": "manhole_193_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387180.719124856637791, 5855870.194651792757213 ], [ 1387131.003996425773948, 5855874.064550469629467 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1076", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.79998779296875, "elevtn_dn": 932.79998779296875, "invlev_up": 930.29998779296875, "invlev_dn": 930.29998779296875, "manhole_up": "manhole_193_generated", "manhole_dn": "manhole_194_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387131.003996425773948, 5855874.064550469629467 ], [ 1387081.098878284916282, 5855871.158613862469792 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1077", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.79998779296875, "elevtn_dn": 916.79998779296875, "invlev_up": 930.29998779296875, "invlev_dn": 914.29998779296875, "manhole_up": "manhole_194_generated", "manhole_dn": "manhole_195_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387081.098878284916282, 5855871.158613862469792 ], [ 1387031.198060098802671, 5855868.015261265449226 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1078", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 916.79998779296875, "elevtn_dn": 916.79998779296875, "invlev_up": 914.29998779296875, "invlev_dn": 914.29998779296875, "manhole_up": "manhole_195_generated", "manhole_dn": "manhole_196_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387031.198060098802671, 5855868.015261265449226 ], [ 1386981.297241912456229, 5855864.871908667497337 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1079", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 916.79998779296875, "elevtn_dn": 891.79998779296875, "invlev_up": 914.29998779296875, "invlev_dn": 889.29998779296875, "manhole_up": "manhole_196_generated", "manhole_dn": "manhole_197_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386981.297241912456229, 5855864.871908667497337 ], [ 1386931.47147326474078, 5855860.718019699677825 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1080", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.79998779296875, "elevtn_dn": 891.79998779296875, "invlev_up": 889.29998779296875, "invlev_dn": 889.29998779296875, "manhole_up": "manhole_197_generated", "manhole_dn": "manhole_198_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386931.47147326474078, 5855860.718019699677825 ], [ 1386881.600663758814335, 5855857.577047945931554 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1081", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.79998779296875, "elevtn_dn": 857.10003662109375, "invlev_up": 889.29998779296875, "invlev_dn": 854.60003662109375, "manhole_up": "manhole_198_generated", "manhole_dn": "manhole_199_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386881.600663758814335, 5855857.577047945931554 ], [ 1386832.545593914575875, 5855864.100992278195918 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1082", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 857.10003662109375, "elevtn_dn": 857.10003662109375, "invlev_up": 854.60003662109375, "invlev_dn": 854.60003662109375, "manhole_up": "manhole_199_generated", "manhole_dn": "manhole_200_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386832.545593914575875, 5855864.100992278195918 ], [ 1386787.06764860637486, 5855884.403254445642233 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1083", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 857.10003662109375, "elevtn_dn": 821.29998779296875, "invlev_up": 854.60003662109375, "invlev_dn": 818.79998779296875, "manhole_up": "manhole_200_generated", "manhole_dn": "manhole_201_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386787.06764860637486, 5855884.403254445642233 ], [ 1386748.278358669718727, 5855915.544586268253624 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1084", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 821.29998779296875, "elevtn_dn": 821.29998779296875, "invlev_up": 818.79998779296875, "invlev_dn": 818.79998779296875, "manhole_up": "manhole_201_generated", "manhole_dn": "manhole_202_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386748.278358669718727, 5855915.544586268253624 ], [ 1386721.155419877264649, 5855957.124278785660863 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1085", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 821.29998779296875, "elevtn_dn": 866.0, "invlev_up": 818.79998779296875, "invlev_dn": 863.5, "manhole_up": "manhole_202_generated", "manhole_dn": "manhole_203_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386721.155419877264649, 5855957.124278785660863 ], [ 1386707.750365849817172, 5856004.850832763127983 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1086", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 866.0, "invlev_up": 863.5, "invlev_dn": 863.5, "manhole_up": "manhole_203_generated", "manhole_dn": "manhole_204_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386707.750365849817172, 5856004.850832763127983 ], [ 1386699.832475832896307, 5856054.133603978902102 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1087", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 866.0, "invlev_up": 863.5, "invlev_dn": 863.5, "manhole_up": "manhole_204_generated", "manhole_dn": "manhole_205_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386699.832475832896307, 5856054.133603978902102 ], [ 1386697.095561265014112, 5856103.986880083568394 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1088", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 884.79998779296875, "invlev_up": 863.5, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_205_generated", "manhole_dn": "manhole_206_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386697.095561265014112, 5856103.986880083568394 ], [ 1386699.401158998254687, 5856153.933416903018951 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1089", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 884.79998779296875, "invlev_up": 882.29998779296875, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_206_generated", "manhole_dn": "manhole_207_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386699.401158998254687, 5856153.933416903018951 ], [ 1386715.699191288091242, 5856201.197657831013203 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1090", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 884.79998779296875, "invlev_up": 882.29998779296875, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_207_generated", "manhole_dn": "manhole_208_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386715.699191288091242, 5856201.197657831013203 ], [ 1386741.121203816728666, 5856244.100116757676005 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1091", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 915.9000244140625, "invlev_up": 882.29998779296875, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_208_generated", "manhole_dn": "manhole_209_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386741.121203816728666, 5856244.100116757676005 ], [ 1386774.051378605188802, 5856281.577651324681938 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1092", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_209_generated", "manhole_dn": "manhole_210_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386774.051378605188802, 5856281.577651324681938 ], [ 1386811.583791718119755, 5856314.587093180976808 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1093", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_210_generated", "manhole_dn": "manhole_211_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386811.583791718119755, 5856314.587093180976808 ], [ 1386839.378956499742344, 5856356.087350118905306 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1094", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_211_generated", "manhole_dn": "manhole_212_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386839.378956499742344, 5856356.087350118905306 ], [ 1386855.653891535941511, 5856403.364181768149137 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1095", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_212_generated", "manhole_dn": "manhole_213_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386855.653891535941511, 5856403.364181768149137 ], [ 1386875.714553950354457, 5856449.116945925168693 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1096", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_213_generated", "manhole_dn": "manhole_214_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386875.714553950354457, 5856449.116945925168693 ], [ 1386912.179653002182022, 5856482.939191372133791 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1097", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_214_generated", "manhole_dn": "manhole_215_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386912.179653002182022, 5856482.939191372133791 ], [ 1386944.191176384687424, 5856520.270725904032588 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1098", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 911.79998779296875, "invlev_up": 907.4000244140625, "invlev_dn": 909.29998779296875, "manhole_up": "manhole_215_generated", "manhole_dn": "manhole_216_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386944.191176384687424, 5856520.270725904032588 ], [ 1386964.188513180473819, 5856566.025075756013393 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1099", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.79998779296875, "elevtn_dn": 911.79998779296875, "invlev_up": 909.29998779296875, "invlev_dn": 909.29998779296875, "manhole_up": "manhole_216_generated", "manhole_dn": "manhole_217_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386964.188513180473819, 5856566.025075756013393 ], [ 1386998.825215350603685, 5856599.261941562406719 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1100", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.79998779296875, "elevtn_dn": 932.0, "invlev_up": 909.29998779296875, "invlev_dn": 929.5, "manhole_up": "manhole_217_generated", "manhole_dn": "manhole_218_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386998.825215350603685, 5856599.261941562406719 ], [ 1387044.828526843106374, 5856618.849377661012113 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1101", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 932.0, "invlev_up": 929.5, "invlev_dn": 929.5, "manhole_up": "manhole_218_generated", "manhole_dn": "manhole_219_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387044.828526843106374, 5856618.849377661012113 ], [ 1387090.831838335609064, 5856638.43681376054883 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1102", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 949.9000244140625, "invlev_up": 929.5, "invlev_dn": 947.4000244140625, "manhole_up": "manhole_219_generated", "manhole_dn": "manhole_220_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387090.831838335609064, 5856638.43681376054883 ], [ 1387136.835149827878922, 5856658.024249859154224 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1103", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 949.9000244140625, "elevtn_dn": 924.4000244140625, "invlev_up": 947.4000244140625, "invlev_dn": 921.9000244140625, "manhole_up": "manhole_220_generated", "manhole_dn": "manhole_221_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387136.835149827878922, 5856658.024249859154224 ], [ 1387178.671980312326923, 5856685.128790453076363 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1104", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 924.4000244140625, "elevtn_dn": 924.4000244140625, "invlev_up": 921.9000244140625, "invlev_dn": 921.9000244140625, "manhole_up": "manhole_221_generated", "manhole_dn": "manhole_222_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387178.671980312326923, 5856685.128790453076363 ], [ 1387217.700535611249506, 5856716.320352808572352 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1105", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 924.4000244140625, "elevtn_dn": 940.0, "invlev_up": 921.9000244140625, "invlev_dn": 937.5, "manhole_up": "manhole_222_generated", "manhole_dn": "manhole_223_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387217.700535611249506, 5856716.320352808572352 ], [ 1387252.016686553368345, 5856752.649443434551358 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1106", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.0, "elevtn_dn": 940.0, "invlev_up": 937.5, "invlev_dn": 937.5, "manhole_up": "manhole_223_generated", "manhole_dn": "manhole_224_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387252.016686553368345, 5856752.649443434551358 ], [ 1387284.798919493798167, 5856790.190159549936652 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1107", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.0, "elevtn_dn": 894.29998779296875, "invlev_up": 937.5, "invlev_dn": 891.79998779296875, "manhole_up": "manhole_224_generated", "manhole_dn": "manhole_225_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387284.798919493798167, 5856790.190159549936652 ], [ 1387273.050185391213745, 5856831.931571422144771 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1108", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 894.29998779296875, "elevtn_dn": 891.5, "invlev_up": 891.79998779296875, "invlev_dn": 889.0, "manhole_up": "manhole_225_generated", "manhole_dn": "manhole_226_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387273.050185391213745, 5856831.931571422144771 ], [ 1387226.106990416301414, 5856849.145192969590425 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1109", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.5, "elevtn_dn": 891.5, "invlev_up": 889.0, "invlev_dn": 889.0, "manhole_up": "manhole_226_generated", "manhole_dn": "manhole_227_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387226.106990416301414, 5856849.145192969590425 ], [ 1387179.163795441389084, 5856866.358814516104758 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1110", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.5, "elevtn_dn": 881.0, "invlev_up": 889.0, "invlev_dn": 878.5, "manhole_up": "manhole_227_generated", "manhole_dn": "manhole_228_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387179.163795441389084, 5856866.358814516104758 ], [ 1387132.220600466709584, 5856883.572436063550413 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1111", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_228_generated", "manhole_dn": "manhole_229_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387132.220600466709584, 5856883.572436063550413 ], [ 1387091.513159692520276, 5856911.129930667579174 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1112", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_229_generated", "manhole_dn": "manhole_230_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387091.513159692520276, 5856911.129930667579174 ], [ 1387071.007118243258446, 5856956.15559543017298 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1113", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_230_generated", "manhole_dn": "manhole_231_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387071.007118243258446, 5856956.15559543017298 ], [ 1387043.749112035380676, 5856996.689189162105322 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1114", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 856.5, "invlev_up": 878.5, "invlev_dn": 854.0, "manhole_up": "manhole_231_generated", "manhole_dn": "manhole_232_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387043.749112035380676, 5856996.689189162105322 ], [ 1387004.639443967491388, 5857027.840532388538122 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1115", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_232_generated", "manhole_dn": "manhole_233_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387004.639443967491388, 5857027.840532388538122 ], [ 1386965.529775899834931, 5857058.991875615902245 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1116", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_233_generated", "manhole_dn": "manhole_234_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386965.529775899834931, 5857058.991875615902245 ], [ 1386926.702535050921142, 5857090.440239730291069 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1117", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_234_generated", "manhole_dn": "manhole_235_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386926.702535050921142, 5857090.440239730291069 ], [ 1386899.700979894958436, 5857131.871505072340369 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1118", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_235_generated", "manhole_dn": "manhole_236_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386899.700979894958436, 5857131.871505072340369 ], [ 1386903.6263940166682, 5857181.005935152061284 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1119", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 867.29998779296875, "invlev_up": 854.0, "invlev_dn": 864.79998779296875, "manhole_up": "manhole_236_generated", "manhole_dn": "manhole_237_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386903.6263940166682, 5857181.005935152061284 ], [ 1386920.841401966754347, 5857227.85734468139708 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1120", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 867.29998779296875, "elevtn_dn": 867.29998779296875, "invlev_up": 864.79998779296875, "invlev_dn": 864.79998779296875, "manhole_up": "manhole_237_generated", "manhole_dn": "manhole_238_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386920.841401966754347, 5857227.85734468139708 ], [ 1386940.647245415020734, 5857273.767048302106559 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1121", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 867.29998779296875, "elevtn_dn": 879.0, "invlev_up": 864.79998779296875, "invlev_dn": 876.5, "manhole_up": "manhole_238_generated", "manhole_dn": "manhole_239_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386940.647245415020734, 5857273.767048302106559 ], [ 1386960.453088863519952, 5857319.676751921884716 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1122", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 879.0, "elevtn_dn": 884.5, "invlev_up": 876.5, "invlev_dn": 882.0, "manhole_up": "manhole_239_generated", "manhole_dn": "manhole_240_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386960.453088863519952, 5857319.676751921884716 ], [ 1386980.258932311786339, 5857365.586455542594194 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1123", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 884.5, "invlev_up": 882.0, "invlev_dn": 882.0, "manhole_up": "manhole_240_generated", "manhole_dn": "manhole_241_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386980.258932311786339, 5857365.586455542594194 ], [ 1387000.064775760285556, 5857411.496159162372351 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1124", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 884.5, "invlev_up": 882.0, "invlev_dn": 882.0, "manhole_up": "manhole_241_generated", "manhole_dn": "manhole_242_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387000.064775760285556, 5857411.496159162372351 ], [ 1387007.528902114601806, 5857459.537025099620223 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1125", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 893.20001220703125, "invlev_up": 882.0, "invlev_dn": 890.70001220703125, "manhole_up": "manhole_242_generated", "manhole_dn": "manhole_243_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387007.528902114601806, 5857459.537025099620223 ], [ 1386963.21676475298591, 5857476.629049208015203 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1126", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 893.20001220703125, "elevtn_dn": 893.70001220703125, "invlev_up": 890.70001220703125, "invlev_dn": 891.20001220703125, "manhole_up": "manhole_243_generated", "manhole_dn": "manhole_244_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386963.21676475298591, 5857476.629049208015203 ], [ 1386913.783934087026864, 5857484.135433598421514 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1127", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 893.70001220703125, "elevtn_dn": 893.70001220703125, "invlev_up": 891.20001220703125, "invlev_dn": 891.20001220703125, "manhole_up": "manhole_244_generated", "manhole_dn": "manhole_245_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386913.783934087026864, 5857484.135433598421514 ], [ 1386870.539328352315351, 5857507.055611960589886 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1128", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 893.70001220703125, "elevtn_dn": 889.70001220703125, "invlev_up": 891.20001220703125, "invlev_dn": 887.20001220703125, "manhole_up": "manhole_245_generated", "manhole_dn": "manhole_246_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386870.539328352315351, 5857507.055611960589886 ], [ 1386832.820274166297168, 5857539.877026806585491 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1129", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.70001220703125, "elevtn_dn": 889.70001220703125, "invlev_up": 887.20001220703125, "invlev_dn": 887.20001220703125, "manhole_up": "manhole_246_generated", "manhole_dn": "manhole_247_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386832.820274166297168, 5857539.877026806585491 ], [ 1386795.101531907683238, 5857572.698800123296678 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1130", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.70001220703125, "elevtn_dn": 872.4000244140625, "invlev_up": 887.20001220703125, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_247_generated", "manhole_dn": "manhole_248_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386795.101531907683238, 5857572.698800123296678 ], [ 1386758.257366374600679, 5857606.496797049418092 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1131", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 872.4000244140625, "invlev_up": 869.9000244140625, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_248_generated", "manhole_dn": "manhole_249_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386758.257366374600679, 5857606.496797049418092 ], [ 1386721.502390186069533, 5857640.394349270500243 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1132", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 872.4000244140625, "invlev_up": 869.9000244140625, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_249_generated", "manhole_dn": "manhole_250_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386721.502390186069533, 5857640.394349270500243 ], [ 1386691.639095245627686, 5857680.292891399934888 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1133", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 860.70001220703125, "invlev_up": 869.9000244140625, "invlev_dn": 858.20001220703125, "manhole_up": "manhole_250_generated", "manhole_dn": "manhole_251_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386691.639095245627686, 5857680.292891399934888 ], [ 1386663.127201205352321, 5857721.366519738920033 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1134", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 860.70001220703125, "elevtn_dn": 864.10003662109375, "invlev_up": 858.20001220703125, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_251_generated", "manhole_dn": "manhole_252_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386663.127201205352321, 5857721.366519738920033 ], [ 1386634.70784462057054, 5857762.504245642572641 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1135", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 864.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_252_generated", "manhole_dn": "manhole_253_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386634.70784462057054, 5857762.504245642572641 ], [ 1386606.28848803602159, 5857803.64197154622525 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1136", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 864.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_253_generated", "manhole_dn": "manhole_254_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386606.28848803602159, 5857803.64197154622525 ], [ 1386577.851668093586341, 5857844.766917760483921 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1137", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 836.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 833.60003662109375, "manhole_up": "manhole_254_generated", "manhole_dn": "manhole_255_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386577.851668093586341, 5857844.766917760483921 ], [ 1386559.479123871540651, 5857890.340473555959761 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1138", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 836.10003662109375, "elevtn_dn": 836.10003662109375, "invlev_up": 833.60003662109375, "invlev_dn": 833.60003662109375, "manhole_up": "manhole_255_generated", "manhole_dn": "manhole_256_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386559.479123871540651, 5857890.340473555959761 ], [ 1386576.858566463226452, 5857935.633445805869997 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1139", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 836.10003662109375, "elevtn_dn": 854.9000244140625, "invlev_up": 833.60003662109375, "invlev_dn": 852.4000244140625, "manhole_up": "manhole_256_generated", "manhole_dn": "manhole_257_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386576.858566463226452, 5857935.633445805869997 ], [ 1386619.073707325849682, 5857961.189545376226306 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1140", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.9000244140625, "elevtn_dn": 854.9000244140625, "invlev_up": 852.4000244140625, "invlev_dn": 852.4000244140625, "manhole_up": "manhole_257_generated", "manhole_dn": "manhole_258_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386619.073707325849682, 5857961.189545376226306 ], [ 1386664.860782509436831, 5857981.27706332411617 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1141", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.9000244140625, "elevtn_dn": 871.60003662109375, "invlev_up": 852.4000244140625, "invlev_dn": 869.10003662109375, "manhole_up": "manhole_258_generated", "manhole_dn": "manhole_259_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386664.860782509436831, 5857981.27706332411617 ], [ 1386710.721602912992239, 5858001.195835201069713 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1142", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 871.60003662109375, "elevtn_dn": 865.10003662109375, "invlev_up": 869.10003662109375, "invlev_dn": 862.60003662109375, "manhole_up": "manhole_259_generated", "manhole_dn": "manhole_260_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386710.721602912992239, 5858001.195835201069713 ], [ 1386756.582423316547647, 5858021.114607078954577 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1143", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 865.10003662109375, "elevtn_dn": 864.70001220703125, "invlev_up": 862.60003662109375, "invlev_dn": 862.20001220703125, "manhole_up": "manhole_260_generated", "manhole_dn": "manhole_261_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386756.582423316547647, 5858021.114607078954577 ], [ 1386802.443243720103055, 5858041.033378956839442 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1144", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.70001220703125, "elevtn_dn": 864.70001220703125, "invlev_up": 862.20001220703125, "invlev_dn": 862.20001220703125, "manhole_up": "manhole_261_generated", "manhole_dn": "manhole_262_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386802.443243720103055, 5858041.033378956839442 ], [ 1386848.304064123658463, 5858060.952150834724307 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1145", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.70001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 862.20001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_262_generated", "manhole_dn": "manhole_263_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386848.304064123658463, 5858060.952150834724307 ], [ 1386892.843548113014549, 5858083.471454747952521 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1146", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_263_generated", "manhole_dn": "manhole_264_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386892.843548113014549, 5858083.471454747952521 ], [ 1386931.443847785238177, 5858115.251781782135367 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1147", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 853.60003662109375, "invlev_up": 856.70001220703125, "invlev_dn": 851.10003662109375, "manhole_up": "manhole_264_generated", "manhole_dn": "manhole_265_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386931.443847785238177, 5858115.251781782135367 ], [ 1386970.044147457228974, 5858147.032108817249537 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1148", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 853.60003662109375, "elevtn_dn": 853.60003662109375, "invlev_up": 851.10003662109375, "invlev_dn": 851.10003662109375, "manhole_up": "manhole_265_generated", "manhole_dn": "manhole_266_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386970.044147457228974, 5858147.032108817249537 ], [ 1387008.644447129452601, 5858178.812435851432383 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1149", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 853.60003662109375, "elevtn_dn": 842.4000244140625, "invlev_up": 851.10003662109375, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_266_generated", "manhole_dn": "manhole_267_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387008.644447129452601, 5858178.812435851432383 ], [ 1387047.244746801443398, 5858210.592762886546552 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1150", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 842.4000244140625, "invlev_up": 839.9000244140625, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_267_generated", "manhole_dn": "manhole_268_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387047.244746801443398, 5858210.592762886546552 ], [ 1387085.845046473667026, 5858242.373089920729399 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1151", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 842.4000244140625, "invlev_up": 839.9000244140625, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_268_generated", "manhole_dn": "manhole_269_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387085.845046473667026, 5858242.373089920729399 ], [ 1387124.445346145657822, 5858274.153416955843568 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1152", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 827.60003662109375, "invlev_up": 839.9000244140625, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_269_generated", "manhole_dn": "manhole_270_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387124.445346145657822, 5858274.153416955843568 ], [ 1387163.04564581788145, 5858305.933743990026414 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1153", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_270_generated", "manhole_dn": "manhole_271_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387163.04564581788145, 5858305.933743990026414 ], [ 1387201.829349192325026, 5858337.489215047098696 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1154", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 837.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 835.10003662109375, "manhole_up": "manhole_271_generated", "manhole_dn": "manhole_272_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387201.829349192325026, 5858337.489215047098696 ], [ 1387246.200623227981851, 5858359.687651782296598 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1155", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 837.60003662109375, "elevtn_dn": 837.60003662109375, "invlev_up": 835.10003662109375, "invlev_dn": 835.10003662109375, "manhole_up": "manhole_272_generated", "manhole_dn": "manhole_273_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387246.200623227981851, 5858359.687651782296598 ], [ 1387293.201938283629715, 5858376.741938757710159 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1156", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 837.60003662109375, "elevtn_dn": 843.79998779296875, "invlev_up": 835.10003662109375, "invlev_dn": 841.29998779296875, "manhole_up": "manhole_273_generated", "manhole_dn": "manhole_274_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387293.201938283629715, 5858376.741938757710159 ], [ 1387334.200528149493039, 5858401.732468435540795 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1157", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 843.79998779296875, "elevtn_dn": 822.60003662109375, "invlev_up": 841.29998779296875, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_274_generated", "manhole_dn": "manhole_275_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387334.200528149493039, 5858401.732468435540795 ], [ 1387307.843875054037198, 5858437.110805934295058 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1158", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 822.60003662109375, "invlev_up": 820.10003662109375, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_275_generated", "manhole_dn": "manhole_276_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387307.843875054037198, 5858437.110805934295058 ], [ 1387260.279569417703897, 5858425.045736069791019 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1159", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 820.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_276_generated", "manhole_dn": "manhole_277_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387260.279569417703897, 5858425.045736069791019 ], [ 1387211.448235018178821, 5858414.300554806366563 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1160", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_277_generated", "manhole_dn": "manhole_278_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387211.448235018178821, 5858414.300554806366563 ], [ 1387162.612191663123667, 5858403.576134512200952 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1161", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 822.29998779296875, "invlev_up": 825.10003662109375, "invlev_dn": 819.79998779296875, "manhole_up": "manhole_278_generated", "manhole_dn": "manhole_279_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387162.612191663123667, 5858403.576134512200952 ], [ 1387113.700150535441935, 5858393.210482948459685 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1162", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.29998779296875, "elevtn_dn": 822.29998779296875, "invlev_up": 819.79998779296875, "invlev_dn": 819.79998779296875, "manhole_up": "manhole_279_generated", "manhole_dn": "manhole_280_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387113.700150535441935, 5858393.210482948459685 ], [ 1387064.993171223672107, 5858381.975642333738506 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1163", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.29998779296875, "elevtn_dn": 827.79998779296875, "invlev_up": 819.79998779296875, "invlev_dn": 825.29998779296875, "manhole_up": "manhole_280_generated", "manhole_dn": "manhole_281_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387064.993171223672107, 5858381.975642333738506 ], [ 1387015.796386598376557, 5858376.342007979750633 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1164", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.79998779296875, "elevtn_dn": 827.79998779296875, "invlev_up": 825.29998779296875, "invlev_dn": 825.29998779296875, "manhole_up": "manhole_281_generated", "manhole_dn": "manhole_282_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387015.796386598376557, 5858376.342007979750633 ], [ 1386966.208506174152717, 5858382.746259398758411 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1165", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.79998779296875, "elevtn_dn": 833.9000244140625, "invlev_up": 825.29998779296875, "invlev_dn": 831.4000244140625, "manhole_up": "manhole_282_generated", "manhole_dn": "manhole_283_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386966.208506174152717, 5858382.746259398758411 ], [ 1386916.676812386140227, 5858389.559525708667934 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1166", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 833.9000244140625, "elevtn_dn": 833.9000244140625, "invlev_up": 831.4000244140625, "invlev_dn": 831.4000244140625, "manhole_up": "manhole_283_generated", "manhole_dn": "manhole_284_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386916.676812386140227, 5858389.559525708667934 ], [ 1386867.198860567295924, 5858396.764010772109032 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1167", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 833.9000244140625, "elevtn_dn": 833.20001220703125, "invlev_up": 831.4000244140625, "invlev_dn": 830.70001220703125, "manhole_up": "manhole_284_generated", "manhole_dn": "manhole_285_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386867.198860567295924, 5858396.764010772109032 ], [ 1386820.816385147860274, 5858411.854353901930153 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1168", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 833.20001220703125, "elevtn_dn": 809.60003662109375, "invlev_up": 830.70001220703125, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_285_generated", "manhole_dn": "manhole_286_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386820.816385147860274, 5858411.854353901930153 ], [ 1386841.361234750133008, 5858445.514383808709681 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1169", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 809.79998779296875, "invlev_up": 807.10003662109375, "invlev_dn": 807.29998779296875, "manhole_up": "manhole_286_generated", "manhole_dn": "manhole_287_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386841.361234750133008, 5858445.514383808709681 ], [ 1386890.796275103231892, 5858452.915634987875819 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1170", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.79998779296875, "elevtn_dn": 809.79998779296875, "invlev_up": 807.29998779296875, "invlev_dn": 807.29998779296875, "manhole_up": "manhole_287_generated", "manhole_dn": "manhole_288_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386890.796275103231892, 5858452.915634987875819 ], [ 1386940.277140651131049, 5858460.100081093609333 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1171", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.79998779296875, "elevtn_dn": 805.4000244140625, "invlev_up": 807.29998779296875, "invlev_dn": 802.9000244140625, "manhole_up": "manhole_288_generated", "manhole_dn": "manhole_289_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386940.277140651131049, 5858460.100081093609333 ], [ 1386989.847997799050063, 5858466.483407464809716 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1172", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.4000244140625, "elevtn_dn": 805.4000244140625, "invlev_up": 802.9000244140625, "invlev_dn": 802.9000244140625, "manhole_up": "manhole_289_generated", "manhole_dn": "manhole_290_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386989.847997799050063, 5858466.483407464809716 ], [ 1387039.689648573985323, 5858470.45608530472964 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1173", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.4000244140625, "elevtn_dn": 804.60003662109375, "invlev_up": 802.9000244140625, "invlev_dn": 802.10003662109375, "manhole_up": "manhole_290_generated", "manhole_dn": "manhole_291_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387039.689648573985323, 5858470.45608530472964 ], [ 1387088.843806148739532, 5858479.424946941435337 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1174", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.60003662109375, "elevtn_dn": 809.9000244140625, "invlev_up": 802.10003662109375, "invlev_dn": 807.4000244140625, "manhole_up": "manhole_291_generated", "manhole_dn": "manhole_292_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387088.843806148739532, 5858479.424946941435337 ], [ 1387137.90604472765699, 5858489.061806742101908 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1175", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.9000244140625, "elevtn_dn": 809.9000244140625, "invlev_up": 807.4000244140625, "invlev_dn": 807.4000244140625, "manhole_up": "manhole_292_generated", "manhole_dn": "manhole_293_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387137.90604472765699, 5858489.061806742101908 ], [ 1387186.336529975291342, 5858500.87968063633889 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1176", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.9000244140625, "elevtn_dn": 822.60003662109375, "invlev_up": 807.4000244140625, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_293_generated", "manhole_dn": "manhole_294_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387186.336529975291342, 5858500.87968063633889 ], [ 1387231.661050535272807, 5858521.423059928230941 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1177", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 787.70001220703125, "invlev_up": 820.10003662109375, "invlev_dn": 785.20001220703125, "manhole_up": "manhole_294_generated", "manhole_dn": "manhole_295_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387231.661050535272807, 5858521.423059928230941 ], [ 1387268.120024613803253, 5858555.03504909388721 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1178", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.70001220703125, "elevtn_dn": 787.70001220703125, "invlev_up": 785.20001220703125, "invlev_dn": 785.20001220703125, "manhole_up": "manhole_295_generated", "manhole_dn": "manhole_296_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387268.120024613803253, 5858555.03504909388721 ], [ 1387300.917169471969828, 5858592.775208213366568 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1179", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.70001220703125, "elevtn_dn": 797.10003662109375, "invlev_up": 785.20001220703125, "invlev_dn": 794.60003662109375, "manhole_up": "manhole_296_generated", "manhole_dn": "manhole_297_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387300.917169471969828, 5858592.775208213366568 ], [ 1387340.521646688459441, 5858622.315198052674532 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1180", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 797.10003662109375, "elevtn_dn": 797.10003662109375, "invlev_up": 794.60003662109375, "invlev_dn": 794.60003662109375, "manhole_up": "manhole_297_generated", "manhole_dn": "manhole_298_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387340.521646688459441, 5858622.315198052674532 ], [ 1387387.476920192595571, 5858639.495844470337033 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1181", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 797.10003662109375, "elevtn_dn": 806.10003662109375, "invlev_up": 794.60003662109375, "invlev_dn": 803.60003662109375, "manhole_up": "manhole_298_generated", "manhole_dn": "manhole_299_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387387.476920192595571, 5858639.495844470337033 ], [ 1387436.116963447071612, 5858650.82861250359565 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1182", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.10003662109375, "elevtn_dn": 806.10003662109375, "invlev_up": 803.60003662109375, "invlev_dn": 803.60003662109375, "manhole_up": "manhole_299_generated", "manhole_dn": "manhole_300_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387436.116963447071612, 5858650.82861250359565 ], [ 1387485.194103535497561, 5858660.261457678861916 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1183", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.10003662109375, "elevtn_dn": 807.70001220703125, "invlev_up": 803.60003662109375, "invlev_dn": 805.20001220703125, "manhole_up": "manhole_300_generated", "manhole_dn": "manhole_301_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387485.194103535497561, 5858660.261457678861916 ], [ 1387533.804190448950976, 5858671.493853995576501 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1184", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.70001220703125, "elevtn_dn": 772.20001220703125, "invlev_up": 805.20001220703125, "invlev_dn": 769.70001220703125, "manhole_up": "manhole_301_generated", "manhole_dn": "manhole_302_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387533.804190448950976, 5858671.493853995576501 ], [ 1387580.2968336828053, 5858689.619015210308135 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1185", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.20001220703125, "elevtn_dn": 778.79998779296875, "invlev_up": 769.70001220703125, "invlev_dn": 776.29998779296875, "manhole_up": "manhole_302_generated", "manhole_dn": "manhole_303_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387580.2968336828053, 5858689.619015210308135 ], [ 1387628.455277157016098, 5858703.062848121859133 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1186", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.79998779296875, "elevtn_dn": 778.79998779296875, "invlev_up": 776.29998779296875, "invlev_dn": 776.29998779296875, "manhole_up": "manhole_303_generated", "manhole_dn": "manhole_304_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387628.455277157016098, 5858703.062848121859133 ], [ 1387677.211432087467983, 5858713.7862489502877 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1187", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.79998779296875, "elevtn_dn": 786.70001220703125, "invlev_up": 776.29998779296875, "invlev_dn": 784.20001220703125, "manhole_up": "manhole_304_generated", "manhole_dn": "manhole_305_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387677.211432087467983, 5858713.7862489502877 ], [ 1387726.995392211945727, 5858712.747126803733408 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1188", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.70001220703125, "elevtn_dn": 786.70001220703125, "invlev_up": 784.20001220703125, "invlev_dn": 784.20001220703125, "manhole_up": "manhole_305_generated", "manhole_dn": "manhole_306_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387726.995392211945727, 5858712.747126803733408 ], [ 1387773.343349169706926, 5858725.014477553777397 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1189", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.70001220703125, "elevtn_dn": 797.70001220703125, "invlev_up": 784.20001220703125, "invlev_dn": 795.20001220703125, "manhole_up": "manhole_306_generated", "manhole_dn": "manhole_307_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387773.343349169706926, 5858725.014477553777397 ], [ 1387806.363672176143155, 5858762.310494473204017 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1190", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 797.70001220703125, "elevtn_dn": 797.70001220703125, "invlev_up": 795.20001220703125, "invlev_dn": 795.20001220703125, "manhole_up": "manhole_307_generated", "manhole_dn": "manhole_308_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387806.363672176143155, 5858762.310494473204017 ], [ 1387799.717027904232964, 5858810.149600365199149 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1191", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 797.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 795.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_308_generated", "manhole_dn": "manhole_309_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387799.717027904232964, 5858810.149600365199149 ], [ 1387771.971139753237367, 5858850.86109375115484 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1192", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_309_generated", "manhole_dn": "manhole_310_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387771.971139753237367, 5858850.86109375115484 ], [ 1387723.07675126590766, 5858854.679317841306329 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1193", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_310_generated", "manhole_dn": "manhole_311_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387723.07675126590766, 5858854.679317841306329 ], [ 1387673.274138238513842, 5858850.996178055182099 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1194", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_311_generated", "manhole_dn": "manhole_312_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387673.274138238513842, 5858850.996178055182099 ], [ 1387624.170362570788711, 5858858.384703231044114 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1195", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_312_generated", "manhole_dn": "manhole_313_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387624.170362570788711, 5858858.384703231044114 ], [ 1387575.715393897145987, 5858857.046076283790171 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1196", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_313_generated", "manhole_dn": "manhole_314_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387575.715393897145987, 5858857.046076283790171 ], [ 1387529.438332577701658, 5858838.116818149574101 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1197", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_314_generated", "manhole_dn": "manhole_315_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387529.438332577701658, 5858838.116818149574101 ], [ 1387481.179235466290265, 5858825.222027675248682 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1198", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_315_generated", "manhole_dn": "manhole_316_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387481.179235466290265, 5858825.222027675248682 ], [ 1387432.215501294471323, 5858815.797906777821481 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1199", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 772.79998779296875, "invlev_up": 774.70001220703125, "invlev_dn": 770.29998779296875, "manhole_up": "manhole_316_generated", "manhole_dn": "manhole_317_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387432.215501294471323, 5858815.797906777821481 ], [ 1387382.431881646160036, 5858811.154251328669488 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1200", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.79998779296875, "elevtn_dn": 747.10003662109375, "invlev_up": 770.29998779296875, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_317_generated", "manhole_dn": "manhole_318_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387382.431881646160036, 5858811.154251328669488 ], [ 1387336.607072548242286, 5858824.075685098767281 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1201", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 747.10003662109375, "invlev_up": 744.60003662109375, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_318_generated", "manhole_dn": "manhole_319_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387336.607072548242286, 5858824.075685098767281 ], [ 1387327.458137275883928, 5858870.88596049696207 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1202", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 747.10003662109375, "invlev_up": 744.60003662109375, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_319_generated", "manhole_dn": "manhole_320_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387327.458137275883928, 5858870.88596049696207 ], [ 1387344.619252334116027, 5858917.848375800997019 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1203", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 773.70001220703125, "invlev_up": 744.60003662109375, "invlev_dn": 771.20001220703125, "manhole_up": "manhole_320_generated", "manhole_dn": "manhole_321_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387344.619252334116027, 5858917.848375800997019 ], [ 1387358.089983508689329, 5858965.710649829357862 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1204", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 773.70001220703125, "elevtn_dn": 773.70001220703125, "invlev_up": 771.20001220703125, "invlev_dn": 771.20001220703125, "manhole_up": "manhole_321_generated", "manhole_dn": "manhole_322_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387358.089983508689329, 5858965.710649829357862 ], [ 1387329.564612702699378, 5859003.583583393134177 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1205", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 773.70001220703125, "elevtn_dn": 774.29998779296875, "invlev_up": 771.20001220703125, "invlev_dn": 771.79998779296875, "manhole_up": "manhole_322_generated", "manhole_dn": "manhole_323_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387329.564612702699378, 5859003.583583393134177 ], [ 1387285.783744251355529, 5858993.703191691078246 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1206", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.29998779296875, "elevtn_dn": 774.29998779296875, "invlev_up": 771.79998779296875, "invlev_dn": 771.79998779296875, "manhole_up": "manhole_323_generated", "manhole_dn": "manhole_324_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387285.783744251355529, 5858993.703191691078246 ], [ 1387248.355973182013258, 5858961.31797497626394 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1207", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.29998779296875, "elevtn_dn": 769.4000244140625, "invlev_up": 771.79998779296875, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_324_generated", "manhole_dn": "manhole_325_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387248.355973182013258, 5858961.31797497626394 ], [ 1387199.500433639157563, 5858963.645901591517031 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1208", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 769.4000244140625, "invlev_up": 766.9000244140625, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_325_generated", "manhole_dn": "manhole_326_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387199.500433639157563, 5858963.645901591517031 ], [ 1387151.482699199579656, 5858977.583961015567183 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1209", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 762.60003662109375, "invlev_up": 766.9000244140625, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_326_generated", "manhole_dn": "manhole_327_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387151.482699199579656, 5858977.583961015567183 ], [ 1387103.632611613254994, 5858992.082134889438748 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1210", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 762.60003662109375, "invlev_up": 760.10003662109375, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_327_generated", "manhole_dn": "manhole_328_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387103.632611613254994, 5858992.082134889438748 ], [ 1387055.853339510038495, 5859006.816905959509313 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1211", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 755.79998779296875, "invlev_up": 760.10003662109375, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_328_generated", "manhole_dn": "manhole_329_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387055.853339510038495, 5859006.816905959509313 ], [ 1387008.074067406589165, 5859021.551677029579878 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1212", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_329_generated", "manhole_dn": "manhole_330_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387008.074067406589165, 5859021.551677029579878 ], [ 1386960.294795303372666, 5859036.286448099650443 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1213", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 749.5, "invlev_up": 753.29998779296875, "invlev_dn": 747.0, "manhole_up": "manhole_330_generated", "manhole_dn": "manhole_331_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386960.294795303372666, 5859036.286448099650443 ], [ 1386912.515523200156167, 5859051.021219169721007 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1214", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 749.5, "elevtn_dn": 749.5, "invlev_up": 747.0, "invlev_dn": 747.0, "manhole_up": "manhole_331_generated", "manhole_dn": "manhole_332_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386912.515523200156167, 5859051.021219169721007 ], [ 1386864.736251096706837, 5859065.755990239791572 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1215", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 749.5, "elevtn_dn": 727.10003662109375, "invlev_up": 747.0, "invlev_dn": 724.60003662109375, "manhole_up": "manhole_332_generated", "manhole_dn": "manhole_333_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386864.736251096706837, 5859065.755990239791572 ], [ 1386816.956978993490338, 5859080.490761309862137 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1216", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.10003662109375, "elevtn_dn": 752.29998779296875, "invlev_up": 724.60003662109375, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_333_generated", "manhole_dn": "manhole_334_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386816.956978993490338, 5859080.490761309862137 ], [ 1386769.832018451532349, 5859096.976014334708452 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1217", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 738.0, "invlev_up": 749.79998779296875, "invlev_dn": 735.5, "manhole_up": "manhole_334_generated", "manhole_dn": "manhole_335_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386769.832018451532349, 5859096.976014334708452 ], [ 1386724.102282747160643, 5859117.193917133845389 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1218", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 738.0, "invlev_up": 735.5, "invlev_dn": 735.5, "manhole_up": "manhole_335_generated", "manhole_dn": "manhole_336_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386724.102282747160643, 5859117.193917133845389 ], [ 1386678.372547042788938, 5859137.411819933913648 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1219", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 732.79998779296875, "invlev_up": 735.5, "invlev_dn": 730.29998779296875, "manhole_up": "manhole_336_generated", "manhole_dn": "manhole_337_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386678.372547042788938, 5859137.411819933913648 ], [ 1386632.642811338417232, 5859157.629722733050585 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1220", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.79998779296875, "elevtn_dn": 732.79998779296875, "invlev_up": 730.29998779296875, "invlev_dn": 730.29998779296875, "manhole_up": "manhole_337_generated", "manhole_dn": "manhole_338_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386632.642811338417232, 5859157.629722733050585 ], [ 1386586.913075634045526, 5859177.847625533118844 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1221", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.79998779296875, "elevtn_dn": 732.60003662109375, "invlev_up": 730.29998779296875, "invlev_dn": 730.10003662109375, "manhole_up": "manhole_338_generated", "manhole_dn": "manhole_339_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386586.913075634045526, 5859177.847625533118844 ], [ 1386541.181931287748739, 5859198.062337793409824 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1222", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.60003662109375, "elevtn_dn": 732.60003662109375, "invlev_up": 730.10003662109375, "invlev_dn": 730.10003662109375, "manhole_up": "manhole_339_generated", "manhole_dn": "manhole_340_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386541.181931287748739, 5859198.062337793409824 ], [ 1386495.431538854492828, 5859218.233453613705933 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1223", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.60003662109375, "elevtn_dn": 742.5, "invlev_up": 730.10003662109375, "invlev_dn": 740.0, "manhole_up": "manhole_340_generated", "manhole_dn": "manhole_341_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386495.431538854492828, 5859218.233453613705933 ], [ 1386449.681146421469748, 5859238.404569433070719 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1224", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 742.5, "invlev_up": 740.0, "invlev_dn": 740.0, "manhole_up": "manhole_341_generated", "manhole_dn": "manhole_342_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386449.681146421469748, 5859238.404569433070719 ], [ 1386404.749107032548636, 5859260.314221715554595 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1225", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 717.60003662109375, "invlev_up": 740.0, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_342_generated", "manhole_dn": "manhole_343_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386404.749107032548636, 5859260.314221715554595 ], [ 1386360.756595908896998, 5859284.020064728334546 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1226", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 717.60003662109375, "invlev_up": 715.10003662109375, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_343_generated", "manhole_dn": "manhole_344_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386360.756595908896998, 5859284.020064728334546 ], [ 1386317.622744857333601, 5859309.307279178872705 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1227", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 711.0, "invlev_up": 715.10003662109375, "invlev_dn": 708.5, "manhole_up": "manhole_344_generated", "manhole_dn": "manhole_345_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386317.622744857333601, 5859309.307279178872705 ], [ 1386274.488893805770203, 5859334.594493629410863 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1228", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 711.0, "elevtn_dn": 717.60003662109375, "invlev_up": 708.5, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_345_generated", "manhole_dn": "manhole_346_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386274.488893805770203, 5859334.594493629410863 ], [ 1386231.354723542230204, 5859359.881163572892547 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1229", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 739.0, "invlev_up": 715.10003662109375, "invlev_dn": 736.5, "manhole_up": "manhole_346_generated", "manhole_dn": "manhole_347_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386231.354723542230204, 5859359.881163572892547 ], [ 1386188.788941488368437, 5859385.978958465158939 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1230", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 739.0, "invlev_up": 736.5, "invlev_dn": 736.5, "manhole_up": "manhole_347_generated", "manhole_dn": "manhole_348_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386188.788941488368437, 5859385.978958465158939 ], [ 1386153.170269979629666, 5859420.751348914578557 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1231", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 739.0, "invlev_up": 736.5, "invlev_dn": 736.5, "manhole_up": "manhole_348_generated", "manhole_dn": "manhole_349_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386153.170269979629666, 5859420.751348914578557 ], [ 1386127.241226618411019, 5859463.08446778729558 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1232", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 770.60003662109375, "invlev_up": 736.5, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_349_generated", "manhole_dn": "manhole_350_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386127.241226618411019, 5859463.08446778729558 ], [ 1386108.996456971857697, 5859509.052053713239729 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1233", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_350_generated", "manhole_dn": "manhole_351_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386108.996456971857697, 5859509.052053713239729 ], [ 1386105.954033384332433, 5859558.959127158857882 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1234", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_351_generated", "manhole_dn": "manhole_352_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386105.954033384332433, 5859558.959127158857882 ], [ 1386101.917093347059563, 5859608.782215913757682 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1235", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 779.79998779296875, "invlev_up": 768.10003662109375, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_352_generated", "manhole_dn": "manhole_353_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386101.917093347059563, 5859608.782215913757682 ], [ 1386088.458339030388743, 5859656.652665913105011 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1236", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 779.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_353_generated", "manhole_dn": "manhole_354_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386088.458339030388743, 5859656.652665913105011 ], [ 1386075.652030121767893, 5859704.419184413738549 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1237", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 779.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_354_generated", "manhole_dn": "manhole_355_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386075.652030121767893, 5859704.419184413738549 ], [ 1386076.574770522769541, 5859754.410392354242504 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1238", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_355_generated", "manhole_dn": "manhole_356_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386076.574770522769541, 5859754.410392354242504 ], [ 1386077.497510923538357, 5859804.401600294746459 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1239", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_356_generated", "manhole_dn": "manhole_357_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386077.497510923538357, 5859804.401600294746459 ], [ 1386078.420251324307173, 5859854.392808235250413 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E195", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 814.29998779296875, "elevtn_dn": 802.9000244140625, "invlev_up": 811.79998779296875, "invlev_dn": 800.4000244140625, "manhole_up": "manhole_358_generated", "manhole_dn": "manhole_359_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384050.267680946970358, 5856698.702001548372209 ], [ 1384085.778961833100766, 5856733.441067186184227 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E196", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.9000244140625, "elevtn_dn": 802.9000244140625, "invlev_up": 800.4000244140625, "invlev_dn": 800.4000244140625, "manhole_up": "manhole_359_generated", "manhole_dn": "manhole_360_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384085.778961833100766, 5856733.441067186184227 ], [ 1384122.993944165529683, 5856766.592179889790714 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E197", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.9000244140625, "elevtn_dn": 816.29998779296875, "invlev_up": 800.4000244140625, "invlev_dn": 813.79998779296875, "manhole_up": "manhole_360_generated", "manhole_dn": "manhole_361_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384122.993944165529683, 5856766.592179889790714 ], [ 1384160.350959801580757, 5856799.578122235834599 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E198", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.29998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 813.79998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_361_generated", "manhole_dn": "manhole_362_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384160.350959801580757, 5856799.578122235834599 ], [ 1384198.384374253917485, 5856831.724873264320195 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E199", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 798.29998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_362_generated", "manhole_dn": "manhole_363_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384198.384374253917485, 5856831.724873264320195 ], [ 1384230.112839305773377, 5856870.159957353956997 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E200", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 793.9000244140625, "invlev_up": 798.29998779296875, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_363_generated", "manhole_dn": "manhole_364_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384230.112839305773377, 5856870.159957353956997 ], [ 1384259.121702386764809, 5856910.628996902145445 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E201", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 807.60003662109375, "invlev_up": 791.4000244140625, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_364_generated", "manhole_dn": "manhole_365_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384259.121702386764809, 5856910.628996902145445 ], [ 1384287.023718592710793, 5856951.925833041779697 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E202", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_365_generated", "manhole_dn": "manhole_366_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384287.023718592710793, 5856951.925833041779697 ], [ 1384314.929269487503916, 5856993.22028074786067 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E203", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_366_generated", "manhole_dn": "manhole_367_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384314.929269487503916, 5856993.22028074786067 ], [ 1384344.819752591196448, 5857033.056208833120763 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E204", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_367_generated", "manhole_dn": "manhole_368_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384344.819752591196448, 5857033.056208833120763 ], [ 1384375.891110281459987, 5857072.024425559677184 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E205", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_368_generated", "manhole_dn": "manhole_369_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384375.891110281459987, 5857072.024425559677184 ], [ 1384412.732155854580924, 5857105.507668288424611 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E206", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_369_generated", "manhole_dn": "manhole_370_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384412.732155854580924, 5857105.507668288424611 ], [ 1384450.07948348694481, 5857138.509612204506993 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E207", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_370_generated", "manhole_dn": "manhole_371_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384450.07948348694481, 5857138.509612204506993 ], [ 1384487.42686335532926, 5857171.511497005820274 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E208", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 805.0, "invlev_up": 793.4000244140625, "invlev_dn": 802.5, "manhole_up": "manhole_371_generated", "manhole_dn": "manhole_372_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384487.42686335532926, 5857171.511497005820274 ], [ 1384525.207759798038751, 5857204.014277670532465 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E209", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 796.29998779296875, "invlev_up": 802.5, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_372_generated", "manhole_dn": "manhole_373_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384525.207759798038751, 5857204.014277670532465 ], [ 1384563.111988977529109, 5857236.375065575353801 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E210", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 796.29998779296875, "invlev_up": 793.79998779296875, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_373_generated", "manhole_dn": "manhole_374_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384563.111988977529109, 5857236.375065575353801 ], [ 1384601.016218156786636, 5857268.735853480175138 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E211", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 786.10003662109375, "invlev_up": 793.79998779296875, "invlev_dn": 783.60003662109375, "manhole_up": "manhole_374_generated", "manhole_dn": "manhole_375_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384601.016218156786636, 5857268.735853480175138 ], [ 1384638.920447336044163, 5857301.096641384996474 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E212", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.10003662109375, "elevtn_dn": 794.29998779296875, "invlev_up": 783.60003662109375, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_375_generated", "manhole_dn": "manhole_376_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384638.920447336044163, 5857301.096641384996474 ], [ 1384669.604954990325496, 5857340.313404724933207 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E213", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 794.29998779296875, "invlev_up": 791.79998779296875, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_376_generated", "manhole_dn": "manhole_377_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384669.604954990325496, 5857340.313404724933207 ], [ 1384699.518247769214213, 5857380.104403200559318 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E214", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 794.29998779296875, "invlev_up": 791.79998779296875, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_377_generated", "manhole_dn": "manhole_378_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384699.518247769214213, 5857380.104403200559318 ], [ 1384719.806332413339987, 5857425.627417215146124 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E215", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 782.0, "invlev_up": 791.79998779296875, "invlev_dn": 779.5, "manhole_up": "manhole_378_generated", "manhole_dn": "manhole_379_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384719.806332413339987, 5857425.627417215146124 ], [ 1384740.094417057465762, 5857471.150431229732931 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E216", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 782.0, "elevtn_dn": 789.70001220703125, "invlev_up": 779.5, "invlev_dn": 787.20001220703125, "manhole_up": "manhole_379_generated", "manhole_dn": "manhole_380_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384740.094417057465762, 5857471.150431229732931 ], [ 1384760.382501701591536, 5857516.673445244319737 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E217", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 789.70001220703125, "elevtn_dn": 789.70001220703125, "invlev_up": 787.20001220703125, "invlev_dn": 787.20001220703125, "manhole_up": "manhole_380_generated", "manhole_dn": "manhole_381_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384760.382501701591536, 5857516.673445244319737 ], [ 1384780.670586345717311, 5857562.196459258906543 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E218", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 789.70001220703125, "elevtn_dn": 796.5, "invlev_up": 787.20001220703125, "invlev_dn": 794.0, "manhole_up": "manhole_381_generated", "manhole_dn": "manhole_382_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384780.670586345717311, 5857562.196459258906543 ], [ 1384802.672203443944454, 5857606.838341221213341 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E219", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.5, "elevtn_dn": 771.9000244140625, "invlev_up": 794.0, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_382_generated", "manhole_dn": "manhole_383_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384802.672203443944454, 5857606.838341221213341 ], [ 1384827.896526007680222, 5857649.823044718243182 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E220", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_383_generated", "manhole_dn": "manhole_384_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384827.896526007680222, 5857649.823044718243182 ], [ 1384854.757882944308221, 5857691.606820800341666 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E221", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_384_generated", "manhole_dn": "manhole_385_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384854.757882944308221, 5857691.606820800341666 ], [ 1384888.185768931638449, 5857728.573395187035203 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E222", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_385_generated", "manhole_dn": "manhole_386_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384888.185768931638449, 5857728.573395187035203 ], [ 1384921.613654918735847, 5857765.539969574660063 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E223", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 755.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_386_generated", "manhole_dn": "manhole_387_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384921.613654918735847, 5857765.539969574660063 ], [ 1384956.145453942706808, 5857801.445756647735834 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E224", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 755.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_387_generated", "manhole_dn": "manhole_388_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384956.145453942706808, 5857801.445756647735834 ], [ 1384991.751306539867073, 5857836.319449373520911 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E225", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 746.0, "invlev_up": 755.4000244140625, "invlev_dn": 743.5, "manhole_up": "manhole_388_generated", "manhole_dn": "manhole_389_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384991.751306539867073, 5857836.319449373520911 ], [ 1385027.357159137027338, 5857871.193142099305987 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E226", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 746.0, "elevtn_dn": 755.79998779296875, "invlev_up": 743.5, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_389_generated", "manhole_dn": "manhole_390_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385027.357159137027338, 5857871.193142099305987 ], [ 1385062.963011734187603, 5857906.066834825091064 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E227", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 728.60003662109375, "invlev_up": 753.29998779296875, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_390_generated", "manhole_dn": "manhole_391_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385062.963011734187603, 5857906.066834825091064 ], [ 1385098.568864331347868, 5857940.940527551807463 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E228", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 728.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_391_generated", "manhole_dn": "manhole_392_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385098.568864331347868, 5857940.940527551807463 ], [ 1385135.753846400883049, 5857974.029479116201401 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E229", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 728.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_392_generated", "manhole_dn": "manhole_393_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385135.753846400883049, 5857974.029479116201401 ], [ 1385175.738456205930561, 5858003.622975903563201 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E230", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 735.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 733.10003662109375, "manhole_up": "manhole_393_generated", "manhole_dn": "manhole_394_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385175.738456205930561, 5858003.622975903563201 ], [ 1385218.653756857383996, 5858028.965196672827005 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E231", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 735.60003662109375, "elevtn_dn": 735.60003662109375, "invlev_up": 733.10003662109375, "invlev_dn": 733.10003662109375, "manhole_up": "manhole_394_generated", "manhole_dn": "manhole_395_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385218.653756857383996, 5858028.965196672827005 ], [ 1385262.454936756985262, 5858052.706982978619635 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E232", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 735.60003662109375, "elevtn_dn": 742.0, "invlev_up": 733.10003662109375, "invlev_dn": 739.5, "manhole_up": "manhole_395_generated", "manhole_dn": "manhole_396_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385262.454936756985262, 5858052.706982978619635 ], [ 1385306.715555034345016, 5858075.618745312094688 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E233", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.0, "elevtn_dn": 742.0, "invlev_up": 739.5, "invlev_dn": 739.5, "manhole_up": "manhole_396_generated", "manhole_dn": "manhole_397_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385306.715555034345016, 5858075.618745312094688 ], [ 1385350.97617331170477, 5858098.530507644638419 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E234", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.0, "elevtn_dn": 736.0, "invlev_up": 739.5, "invlev_dn": 733.5, "manhole_up": "manhole_397_generated", "manhole_dn": "manhole_398_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385350.97617331170477, 5858098.530507644638419 ], [ 1385395.236791589297354, 5858121.442269978113472 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E235", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 736.0, "elevtn_dn": 736.0, "invlev_up": 733.5, "invlev_dn": 733.5, "manhole_up": "manhole_398_generated", "manhole_dn": "manhole_399_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385395.236791589297354, 5858121.442269978113472 ], [ 1385439.497409866657108, 5858144.354032310657203 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E236", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 736.0, "elevtn_dn": 737.9000244140625, "invlev_up": 733.5, "invlev_dn": 735.4000244140625, "manhole_up": "manhole_399_generated", "manhole_dn": "manhole_400_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385439.497409866657108, 5858144.354032310657203 ], [ 1385483.758028144016862, 5858167.265794644132257 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E237", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.9000244140625, "elevtn_dn": 737.9000244140625, "invlev_up": 735.4000244140625, "invlev_dn": 735.4000244140625, "manhole_up": "manhole_400_generated", "manhole_dn": "manhole_401_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385483.758028144016862, 5858167.265794644132257 ], [ 1385528.018646421376616, 5858190.17755697760731 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E238", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.9000244140625, "elevtn_dn": 727.29998779296875, "invlev_up": 735.4000244140625, "invlev_dn": 724.79998779296875, "manhole_up": "manhole_401_generated", "manhole_dn": "manhole_402_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385528.018646421376616, 5858190.17755697760731 ], [ 1385571.606102279853076, 5858214.277655217796564 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E239", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.29998779296875, "elevtn_dn": 727.29998779296875, "invlev_up": 724.79998779296875, "invlev_dn": 724.79998779296875, "manhole_up": "manhole_402_generated", "manhole_dn": "manhole_403_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385571.606102279853076, 5858214.277655217796564 ], [ 1385614.013400863157585, 5858240.461089110001922 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E240", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.29998779296875, "elevtn_dn": 690.60003662109375, "invlev_up": 724.79998779296875, "invlev_dn": 688.10003662109375, "manhole_up": "manhole_403_generated", "manhole_dn": "manhole_404_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385614.013400863157585, 5858240.461089110001922 ], [ 1385656.420699446462095, 5858266.644523002207279 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E241", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 690.60003662109375, "elevtn_dn": 733.60003662109375, "invlev_up": 688.10003662109375, "invlev_dn": 731.10003662109375, "manhole_up": "manhole_404_generated", "manhole_dn": "manhole_405_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385656.420699446462095, 5858266.644523002207279 ], [ 1385698.773111530812457, 5858292.8961898451671 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E242", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 733.60003662109375, "elevtn_dn": 733.60003662109375, "invlev_up": 731.10003662109375, "invlev_dn": 731.10003662109375, "manhole_up": "manhole_405_generated", "manhole_dn": "manhole_406_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385698.773111530812457, 5858292.8961898451671 ], [ 1385733.435650466475636, 5858328.707634637132287 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E243", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 733.60003662109375, "elevtn_dn": 721.60003662109375, "invlev_up": 731.10003662109375, "invlev_dn": 719.10003662109375, "manhole_up": "manhole_406_generated", "manhole_dn": "manhole_407_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385733.435650466475636, 5858328.707634637132287 ], [ 1385768.098189401905984, 5858364.519079428166151 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E244", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 721.60003662109375, "elevtn_dn": 721.60003662109375, "invlev_up": 719.10003662109375, "invlev_dn": 719.10003662109375, "manhole_up": "manhole_407_generated", "manhole_dn": "manhole_408_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385768.098189401905984, 5858364.519079428166151 ], [ 1385795.882535298354924, 5858405.467093757353723 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E245", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 721.60003662109375, "elevtn_dn": 739.0, "invlev_up": 719.10003662109375, "invlev_dn": 736.5, "manhole_up": "manhole_408_generated", "manhole_dn": "manhole_409_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385795.882535298354924, 5858405.467093757353723 ], [ 1385820.377634756267071, 5858448.871486231684685 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E246", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 727.79998779296875, "invlev_up": 736.5, "invlev_dn": 725.29998779296875, "manhole_up": "manhole_409_generated", "manhole_dn": "manhole_410_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385820.377634756267071, 5858448.871486231684685 ], [ 1385841.084314390551299, 5858493.920932004228234 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E247", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.79998779296875, "elevtn_dn": 727.79998779296875, "invlev_up": 725.29998779296875, "invlev_dn": 725.29998779296875, "manhole_up": "manhole_410_generated", "manhole_dn": "manhole_411_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385841.084314390551299, 5858493.920932004228234 ], [ 1385856.076261736918241, 5858541.451897682622075 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E248", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.79998779296875, "elevtn_dn": 734.9000244140625, "invlev_up": 725.29998779296875, "invlev_dn": 732.4000244140625, "manhole_up": "manhole_411_generated", "manhole_dn": "manhole_412_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385856.076261736918241, 5858541.451897682622075 ], [ 1385865.668899663724005, 5858590.250006795860827 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E249", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 734.9000244140625, "elevtn_dn": 734.9000244140625, "invlev_up": 732.4000244140625, "invlev_dn": 732.4000244140625, "manhole_up": "manhole_412_generated", "manhole_dn": "manhole_413_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385865.668899663724005, 5858590.250006795860827 ], [ 1385873.387286560609937, 5858639.487976770848036 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E250", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 734.9000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 732.4000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_413_generated", "manhole_dn": "manhole_414_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385873.387286560609937, 5858639.487976770848036 ], [ 1385875.017949819331989, 5858689.287253175862134 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E251", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 748.9000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_414_generated", "manhole_dn": "manhole_415_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385875.017949819331989, 5858689.287253175862134 ], [ 1385876.432928551919758, 5858739.106416343711317 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E252", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 748.9000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_415_generated", "manhole_dn": "manhole_416_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385876.432928551919758, 5858739.106416343711317 ], [ 1385878.329821793129668, 5858788.908141564577818 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E253", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 748.9000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_416_generated", "manhole_dn": "manhole_417_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385878.329821793129668, 5858788.908141564577818 ], [ 1385880.51921496167779, 5858838.69928275514394 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E254", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_417_generated", "manhole_dn": "manhole_418_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385880.51921496167779, 5858838.69928275514394 ], [ 1385882.620351102668792, 5858888.493530485779047 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E255", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_418_generated", "manhole_dn": "manhole_419_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385882.620351102668792, 5858888.493530485779047 ], [ 1385883.937443709466606, 5858938.315377607010305 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E256", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 766.10003662109375, "invlev_up": 757.20001220703125, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_419_generated", "manhole_dn": "manhole_420_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385883.937443709466606, 5858938.315377607010305 ], [ 1385885.254538560518995, 5858988.137224668636918 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E257", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 766.10003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_420_generated", "manhole_dn": "manhole_421_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385885.254538560518995, 5858988.137224668636918 ], [ 1385890.650534195825458, 5859037.630400610156357 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E258", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 766.10003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_421_generated", "manhole_dn": "manhole_422_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385890.650534195825458, 5859037.630400610156357 ], [ 1385901.777442803606391, 5859086.09239396546036 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E259", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 768.60003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 766.10003662109375, "manhole_up": "manhole_422_generated", "manhole_dn": "manhole_423_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385901.777442803606391, 5859086.09239396546036 ], [ 1385915.397954803425819, 5859134.03436760418117 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E260", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.60003662109375, "elevtn_dn": 762.79998779296875, "invlev_up": 766.10003662109375, "invlev_dn": 760.29998779296875, "manhole_up": "manhole_423_generated", "manhole_dn": "manhole_424_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385915.397954803425819, 5859134.03436760418117 ], [ 1385928.42605347908102, 5859182.139209139160812 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E261", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.79998779296875, "elevtn_dn": 762.5, "invlev_up": 760.29998779296875, "invlev_dn": 760.0, "manhole_up": "manhole_424_generated", "manhole_dn": "manhole_425_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385928.42605347908102, 5859182.139209139160812 ], [ 1385941.228082312969491, 5859230.306202415376902 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E262", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 762.5, "invlev_up": 760.0, "invlev_dn": 760.0, "manhole_up": "manhole_425_generated", "manhole_dn": "manhole_426_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385941.228082312969491, 5859230.306202415376902 ], [ 1385945.092689140234143, 5859279.734331246465445 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E263", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 762.5, "invlev_up": 760.0, "invlev_dn": 760.0, "manhole_up": "manhole_426_generated", "manhole_dn": "manhole_427_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385945.092689140234143, 5859279.734331246465445 ], [ 1385937.902412303024903, 5859328.779896341264248 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E264", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 778.0, "invlev_up": 760.0, "invlev_dn": 775.5, "manhole_up": "manhole_427_generated", "manhole_dn": "manhole_428_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.902412303024903, 5859328.779896341264248 ], [ 1385932.795075723901391, 5859378.173214216716588 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E265", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 778.0, "invlev_up": 775.5, "invlev_dn": 775.5, "manhole_up": "manhole_428_generated", "manhole_dn": "manhole_429_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385932.795075723901391, 5859378.173214216716588 ], [ 1385937.702695531537756, 5859427.770254967734218 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E266", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 778.0, "invlev_up": 775.5, "invlev_dn": 775.5, "manhole_up": "manhole_429_generated", "manhole_dn": "manhole_430_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.702695531537756, 5859427.770254967734218 ], [ 1385939.035937832202762, 5859477.50230407807976 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E267", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 795.9000244140625, "invlev_up": 775.5, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_430_generated", "manhole_dn": "manhole_431_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385939.035937832202762, 5859477.50230407807976 ], [ 1385937.883638251805678, 5859527.328234969638288 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E268", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_431_generated", "manhole_dn": "manhole_432_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.883638251805678, 5859527.328234969638288 ], [ 1385940.515994266141206, 5859576.989168248139322 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E269", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_432_generated", "manhole_dn": "manhole_433_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385940.515994266141206, 5859576.989168248139322 ], [ 1385950.701545101590455, 5859625.530176519416273 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E270", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 815.0, "invlev_up": 793.4000244140625, "invlev_dn": 812.5, "manhole_up": "manhole_433_generated", "manhole_dn": "manhole_434_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385950.701545101590455, 5859625.530176519416273 ], [ 1385970.467743494315073, 5859670.991298755630851 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E271", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 815.0, "elevtn_dn": 815.0, "invlev_up": 812.5, "invlev_dn": 812.5, "manhole_up": "manhole_434_generated", "manhole_dn": "manhole_435_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385970.467743494315073, 5859670.991298755630851 ], [ 1386011.983088220236823, 5859697.862916950136423 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E272", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 815.0, "elevtn_dn": 779.79998779296875, "invlev_up": 812.5, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_435_generated", "manhole_dn": "manhole_436_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386011.983088220236823, 5859697.862916950136423 ], [ 1386052.213596233632416, 5859727.119808158837259 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E273", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_436_generated", "manhole_dn": "manhole_437_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386052.213596233632416, 5859727.119808158837259 ], [ 1386046.501012831227854, 5859771.612671964801848 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E274", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_437_generated", "manhole_dn": "manhole_438_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386046.501012831227854, 5859771.612671964801848 ], [ 1386026.809695787727833, 5859816.873920152895153 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E275", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_438_generated", "manhole_dn": "manhole_439_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386026.809695787727833, 5859816.873920152895153 ], [ 1386030.149607364553958, 5859866.379009906202555 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E276", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_439_generated", "manhole_dn": "manhole_440_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386030.149607364553958, 5859866.379009906202555 ], [ 1386045.250939248362556, 5859913.859036295674741 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_11_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 798.29998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_441_generated", "manhole_dn": "manhole_442_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384196.861816460033879, 5856829.88048410974443 ], [ 1384235.22519311751239, 5856854.977665597572923 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_11_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 793.9000244140625, "invlev_up": 798.29998779296875, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_442_generated", "manhole_dn": "manhole_443_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384235.22519311751239, 5856854.977665597572923 ], [ 1384263.450329831801355, 5856892.038370934315026 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_11_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 793.9000244140625, "invlev_up": 791.4000244140625, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_443_generated", "manhole_dn": "manhole_444_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384263.450329831801355, 5856892.038370934315026 ], [ 1384291.675466545857489, 5856929.099076271057129 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_11_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 807.60003662109375, "invlev_up": 791.4000244140625, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_444_generated", "manhole_dn": "manhole_445_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384291.675466545857489, 5856929.099076271057129 ], [ 1384319.900603260146454, 5856966.159781608730555 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_11_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_445_generated", "manhole_dn": "manhole_446_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384319.900603260146454, 5856966.159781608730555 ], [ 1384347.205867683747783, 5857003.894510924816132 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_11_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 799.0, "invlev_up": 805.10003662109375, "invlev_dn": 796.5, "manhole_up": "manhole_446_generated", "manhole_dn": "manhole_447_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384347.205867683747783, 5857003.894510924816132 ], [ 1384380.322691001230851, 5857036.360282040201128 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_11_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 799.0, "elevtn_dn": 807.60003662109375, "invlev_up": 796.5, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_447_generated", "manhole_dn": "manhole_448_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384380.322691001230851, 5857036.360282040201128 ], [ 1384415.156610523350537, 5857067.291694445535541 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_11_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_448_generated", "manhole_dn": "manhole_449_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384415.156610523350537, 5857067.291694445535541 ], [ 1384449.343575850594789, 5857098.828100205399096 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_11_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_449_generated", "manhole_dn": "manhole_450_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384449.343575850594789, 5857098.828100205399096 ], [ 1384470.004810179118067, 5857139.926174183376133 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_11_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_450_generated", "manhole_dn": "manhole_451_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384470.004810179118067, 5857139.926174183376133 ], [ 1384484.18076178082265, 5857184.301805094815791 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_12_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_452_generated", "manhole_dn": "manhole_453_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384289.06552429520525, 5856954.947841017507017 ], [ 1384305.049610810354352, 5856994.88734863139689 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_12_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_453_generated", "manhole_dn": "manhole_454_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384305.049610810354352, 5856994.88734863139689 ], [ 1384321.033697325503454, 5857034.82685624435544 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_12_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 799.0, "invlev_up": 805.10003662109375, "invlev_dn": 796.5, "manhole_up": "manhole_454_generated", "manhole_dn": "manhole_455_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384321.033697325503454, 5857034.82685624435544 ], [ 1384347.445656489115208, 5857068.672038841992617 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_12_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 799.0, "elevtn_dn": 807.60003662109375, "invlev_up": 796.5, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_455_generated", "manhole_dn": "manhole_456_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384347.445656489115208, 5857068.672038841992617 ], [ 1384374.130628447979689, 5857102.406951548531651 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_12_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_456_generated", "manhole_dn": "manhole_457_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384374.130628447979689, 5857102.406951548531651 ], [ 1384399.587644136510789, 5857137.08541233278811 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_12_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_457_generated", "manhole_dn": "manhole_458_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384399.587644136510789, 5857137.08541233278811 ], [ 1384425.04465982504189, 5857171.763873117044568 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_12_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_458_generated", "manhole_dn": "manhole_459_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384425.04465982504189, 5857171.763873117044568 ], [ 1384456.866520966170356, 5857200.577977900393307 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_15_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_15", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_15", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_459_generated", "manhole_dn": "manhole_460_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384456.866520966170356, 5857200.577977900393307 ], [ 1384480.774830641923472, 5857195.244455400854349 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_17_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_17", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_17", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 805.0, "invlev_up": 793.4000244140625, "invlev_dn": 802.5, "manhole_up": "manhole_459_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384456.866520966170356, 5857200.577977900393307 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_18_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_18", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_18", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_462_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384493.329776774393395, 5857201.952337642200291 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_19_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_19", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_19", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_462_generated", "manhole_dn": "manhole_463_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384493.329776774393395, 5857201.952337642200291 ], [ 1384511.321100181667134, 5857246.008046119473875 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_19_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_19", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_19", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_463_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384511.321100181667134, 5857246.008046119473875 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 796.29998779296875, "invlev_up": 802.5, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_464_generated", "manhole_dn": "manhole_465_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384512.484966830350459, 5857248.858029337599874 ], [ 1384550.208547196350992, 5857281.609186780638993 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 796.29998779296875, "invlev_up": 793.79998779296875, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_465_generated", "manhole_dn": "manhole_466_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384550.208547196350992, 5857281.609186780638993 ], [ 1384587.932127562351525, 5857314.360344224609435 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 809.10003662109375, "invlev_up": 793.79998779296875, "invlev_dn": 806.60003662109375, "manhole_up": "manhole_466_generated", "manhole_dn": "manhole_467_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384587.932127562351525, 5857314.360344224609435 ], [ 1384608.456866907887161, 5857358.785165345296264 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.10003662109375, "elevtn_dn": 809.10003662109375, "invlev_up": 806.60003662109375, "invlev_dn": 806.60003662109375, "manhole_up": "manhole_467_generated", "manhole_dn": "manhole_468_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384608.456866907887161, 5857358.785165345296264 ], [ 1384624.966163935838267, 5857405.935456342995167 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.10003662109375, "elevtn_dn": 794.29998779296875, "invlev_up": 806.60003662109375, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_468_generated", "manhole_dn": "manhole_469_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384624.966163935838267, 5857405.935456342995167 ], [ 1384639.938245237572119, 5857453.586039477027953 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 812.4000244140625, "invlev_up": 791.79998779296875, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_469_generated", "manhole_dn": "manhole_470_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384639.938245237572119, 5857453.586039477027953 ], [ 1384654.3423755497206, 5857501.421464210376143 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 812.4000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_470_generated", "manhole_dn": "manhole_471_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384654.3423755497206, 5857501.421464210376143 ], [ 1384665.748858094681054, 5857550.055336253717542 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 812.4000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_471_generated", "manhole_dn": "manhole_472_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384665.748858094681054, 5857550.055336253717542 ], [ 1384677.04772660904564, 5857598.717872150242329 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 818.9000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 816.4000244140625, "manhole_up": "manhole_472_generated", "manhole_dn": "manhole_473_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384677.04772660904564, 5857598.717872150242329 ], [ 1384688.346595123410225, 5857647.380408045835793 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.9000244140625, "elevtn_dn": 818.9000244140625, "invlev_up": 816.4000244140625, "invlev_dn": 816.4000244140625, "manhole_up": "manhole_473_generated", "manhole_dn": "manhole_474_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384688.346595123410225, 5857647.380408045835793 ], [ 1384699.64546363777481, 5857696.042943941429257 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.9000244140625, "elevtn_dn": 791.0, "invlev_up": 816.4000244140625, "invlev_dn": 788.5, "manhole_up": "manhole_474_generated", "manhole_dn": "manhole_475_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384699.64546363777481, 5857696.042943941429257 ], [ 1384710.944332152139395, 5857744.705479837954044 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 771.9000244140625, "invlev_up": 788.5, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_475_generated", "manhole_dn": "manhole_476_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384710.944332152139395, 5857744.705479837954044 ], [ 1384726.848783193388954, 5857791.671307560056448 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_476_generated", "manhole_dn": "manhole_477_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384726.848783193388954, 5857791.671307560056448 ], [ 1384753.929338480113074, 5857833.199649352580309 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_477_generated", "manhole_dn": "manhole_478_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384753.929338480113074, 5857833.199649352580309 ], [ 1384783.627482200739905, 5857873.006575288251042 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 791.0, "invlev_up": 769.4000244140625, "invlev_dn": 788.5, "manhole_up": "manhole_478_generated", "manhole_dn": "manhole_479_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384783.627482200739905, 5857873.006575288251042 ], [ 1384795.018452654592693, 5857920.637507135979831 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 791.0, "invlev_up": 788.5, "invlev_dn": 788.5, "manhole_up": "manhole_479_generated", "manhole_dn": "manhole_480_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384795.018452654592693, 5857920.637507135979831 ], [ 1384785.075932276435196, 5857969.445633230730891 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 820.10003662109375, "invlev_up": 788.5, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_480_generated", "manhole_dn": "manhole_481_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384785.075932276435196, 5857969.445633230730891 ], [ 1384771.479073295136914, 5858017.516749874688685 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 820.10003662109375, "invlev_up": 817.60003662109375, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_481_generated", "manhole_dn": "manhole_482_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384771.479073295136914, 5858017.516749874688685 ], [ 1384763.32518996251747, 5858066.675425447523594 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 820.10003662109375, "invlev_up": 817.60003662109375, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_482_generated", "manhole_dn": "manhole_483_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384763.32518996251747, 5858066.675425447523594 ], [ 1384757.405406558187678, 5858116.280495692044497 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 847.0, "invlev_up": 817.60003662109375, "invlev_dn": 844.5, "manhole_up": "manhole_483_generated", "manhole_dn": "manhole_484_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384757.405406558187678, 5858116.280495692044497 ], [ 1384746.211964494548738, 5858164.956996791996062 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 847.0, "invlev_up": 844.5, "invlev_dn": 844.5, "manhole_up": "manhole_484_generated", "manhole_dn": "manhole_485_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384746.211964494548738, 5858164.956996791996062 ], [ 1384738.028054837835953, 5858213.862443570047617 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 847.0, "invlev_up": 844.5, "invlev_dn": 844.5, "manhole_up": "manhole_485_generated", "manhole_dn": "manhole_486_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384738.028054837835953, 5858213.862443570047617 ], [ 1384756.479259133106098, 5858259.218586039729416 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 833.20001220703125, "invlev_up": 844.5, "invlev_dn": 830.70001220703125, "manhole_up": "manhole_486_generated", "manhole_dn": "manhole_487_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384756.479259133106098, 5858259.218586039729416 ], [ 1384792.653981153853238, 5858293.25339647103101 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 833.20001220703125, "elevtn_dn": 762.29998779296875, "invlev_up": 830.70001220703125, "invlev_dn": 759.79998779296875, "manhole_up": "manhole_487_generated", "manhole_dn": "manhole_488_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384792.653981153853238, 5858293.25339647103101 ], [ 1384839.146884107263759, 5858310.949097327888012 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.29998779296875, "elevtn_dn": 762.29998779296875, "invlev_up": 759.79998779296875, "invlev_dn": 759.79998779296875, "manhole_up": "manhole_488_generated", "manhole_dn": "manhole_489_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384839.146884107263759, 5858310.949097327888012 ], [ 1384888.517509665805846, 5858307.535864246077836 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.29998779296875, "elevtn_dn": 751.0, "invlev_up": 759.79998779296875, "invlev_dn": 748.5, "manhole_up": "manhole_489_generated", "manhole_dn": "manhole_490_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384888.517509665805846, 5858307.535864246077836 ], [ 1384936.622762819286436, 5858294.068231076002121 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.0, "elevtn_dn": 751.0, "invlev_up": 748.5, "invlev_dn": 748.5, "manhole_up": "manhole_490_generated", "manhole_dn": "manhole_491_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384936.622762819286436, 5858294.068231076002121 ], [ 1384984.637113286415115, 5858280.272530450485647 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.0, "elevtn_dn": 743.20001220703125, "invlev_up": 748.5, "invlev_dn": 740.70001220703125, "manhole_up": "manhole_491_generated", "manhole_dn": "manhole_492_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384984.637113286415115, 5858280.272530450485647 ], [ 1385032.633651287527755, 5858266.414710656739771 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 743.20001220703125, "elevtn_dn": 743.20001220703125, "invlev_up": 740.70001220703125, "invlev_dn": 740.70001220703125, "manhole_up": "manhole_492_generated", "manhole_dn": "manhole_493_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385032.633651287527755, 5858266.414710656739771 ], [ 1385081.886840383987874, 5858258.136644747108221 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 743.20001220703125, "elevtn_dn": 747.60003662109375, "invlev_up": 740.70001220703125, "invlev_dn": 745.10003662109375, "manhole_up": "manhole_493_generated", "manhole_dn": "manhole_494_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385081.886840383987874, 5858258.136644747108221 ], [ 1385131.310463621048257, 5858263.211211345158517 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.60003662109375, "elevtn_dn": 756.79998779296875, "invlev_up": 745.10003662109375, "invlev_dn": 754.29998779296875, "manhole_up": "manhole_494_generated", "manhole_dn": "manhole_495_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385131.310463621048257, 5858263.211211345158517 ], [ 1385177.729395114118233, 5858281.168494092300534 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.79998779296875, "elevtn_dn": 758.9000244140625, "invlev_up": 754.29998779296875, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_495_generated", "manhole_dn": "manhole_496_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385177.729395114118233, 5858281.168494092300534 ], [ 1385219.95651927171275, 5858307.84242575801909 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 758.9000244140625, "invlev_up": 756.4000244140625, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_496_generated", "manhole_dn": "manhole_497_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385219.95651927171275, 5858307.84242575801909 ], [ 1385261.864506913116202, 5858335.034840167500079 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 756.29998779296875, "invlev_up": 756.4000244140625, "invlev_dn": 753.79998779296875, "manhole_up": "manhole_497_generated", "manhole_dn": "manhole_498_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385261.864506913116202, 5858335.034840167500079 ], [ 1385305.658712412696332, 5858358.964500648900867 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 756.29998779296875, "invlev_up": 753.79998779296875, "invlev_dn": 753.79998779296875, "manhole_up": "manhole_498_generated", "manhole_dn": "manhole_499_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385305.658712412696332, 5858358.964500648900867 ], [ 1385350.136275847908109, 5858381.712097893469036 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 750.79998779296875, "invlev_up": 753.79998779296875, "invlev_dn": 748.29998779296875, "manhole_up": "manhole_499_generated", "manhole_dn": "manhole_500_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385350.136275847908109, 5858381.712097893469036 ], [ 1385394.617425152566284, 5858404.452682325616479 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 750.79998779296875, "elevtn_dn": 760.20001220703125, "invlev_up": 748.29998779296875, "invlev_dn": 757.70001220703125, "manhole_up": "manhole_500_generated", "manhole_dn": "manhole_501_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385394.617425152566284, 5858404.452682325616479 ], [ 1385439.245915542822331, 5858426.901898948475718 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 760.20001220703125, "elevtn_dn": 754.29998779296875, "invlev_up": 757.70001220703125, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_501_generated", "manhole_dn": "manhole_502_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385439.245915542822331, 5858426.901898948475718 ], [ 1385483.926139793125913, 5858449.248809035867453 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 754.29998779296875, "invlev_up": 751.79998779296875, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_502_generated", "manhole_dn": "manhole_503_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385483.926139793125913, 5858449.248809035867453 ], [ 1385525.860647091642022, 5858475.8632338559255 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 754.29998779296875, "invlev_up": 751.79998779296875, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_503_generated", "manhole_dn": "manhole_504_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385525.860647091642022, 5858475.8632338559255 ], [ 1385553.357332118786871, 5858517.404887572862208 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 751.70001220703125, "invlev_up": 751.79998779296875, "invlev_dn": 749.20001220703125, "manhole_up": "manhole_504_generated", "manhole_dn": "manhole_505_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385553.357332118786871, 5858517.404887572862208 ], [ 1385579.617479301057756, 5858559.686364834196866 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.70001220703125, "elevtn_dn": 751.70001220703125, "invlev_up": 749.20001220703125, "invlev_dn": 749.20001220703125, "manhole_up": "manhole_505_generated", "manhole_dn": "manhole_506_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385579.617479301057756, 5858559.686364834196866 ], [ 1385621.905693766893819, 5858585.068030893802643 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.70001220703125, "elevtn_dn": 750.9000244140625, "invlev_up": 749.20001220703125, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_506_generated", "manhole_dn": "manhole_507_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385621.905693766893819, 5858585.068030893802643 ], [ 1385664.027273919200525, 5858611.351026647724211 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 750.9000244140625, "invlev_up": 748.4000244140625, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_507_generated", "manhole_dn": "manhole_508_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385664.027273919200525, 5858611.351026647724211 ], [ 1385700.387205619364977, 5858645.507954810746014 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 750.9000244140625, "invlev_up": 748.4000244140625, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_508_generated", "manhole_dn": "manhole_509_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385700.387205619364977, 5858645.507954810746014 ], [ 1385734.601841112133116, 5858681.909404612146318 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 755.79998779296875, "invlev_up": 748.4000244140625, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_509_generated", "manhole_dn": "manhole_510_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385734.601841112133116, 5858681.909404612146318 ], [ 1385768.816476604901254, 5858718.310854412615299 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_510_generated", "manhole_dn": "manhole_511_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385768.816476604901254, 5858718.310854412615299 ], [ 1385802.200311921536922, 5858755.447309947572649 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_511_generated", "manhole_dn": "manhole_512_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385802.200311921536922, 5858755.447309947572649 ], [ 1385834.15946239954792, 5858793.844178703613579 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_21_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 765.0, "invlev_up": 753.79998779296875, "invlev_dn": 762.5, "manhole_up": "manhole_513_generated", "manhole_dn": "manhole_514_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385352.471788094611838, 5858398.70255031902343 ], [ 1385323.609449510695413, 5858430.098599229939282 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_21_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.0, "elevtn_dn": 765.0, "invlev_up": 762.5, "invlev_dn": 762.5, "manhole_up": "manhole_514_generated", "manhole_dn": "manhole_515_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385323.609449510695413, 5858430.098599229939282 ], [ 1385286.388775944709778, 5858419.306091710925102 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_21_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.0, "elevtn_dn": 758.9000244140625, "invlev_up": 762.5, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_515_generated", "manhole_dn": "manhole_516_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385286.388775944709778, 5858419.306091710925102 ], [ 1385252.458742934046313, 5858394.201654580421746 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_21_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 758.9000244140625, "invlev_up": 756.4000244140625, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_516_generated", "manhole_dn": "manhole_517_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385252.458742934046313, 5858394.201654580421746 ], [ 1385217.536378393415362, 5858369.72360460460186 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_21_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 756.79998779296875, "invlev_up": 756.4000244140625, "invlev_dn": 754.29998779296875, "manhole_up": "manhole_517_generated", "manhole_dn": "manhole_518_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385217.536378393415362, 5858369.72360460460186 ], [ 1385177.877519500209019, 5858363.975667187944055 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_23_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_23", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "manhole_up": "manhole_519_generated", "manhole_dn": "manhole_520_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384748.107251951703802, 5858475.46539437584579 ], [ 1384773.662756133358926, 5858482.028828926384449 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_23_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_23", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "manhole_up": "manhole_520_generated", "manhole_dn": "manhole_521_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384773.662756133358926, 5858482.028828926384449 ], [ 1384799.21826031524688, 5858488.592263477854431 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_24_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_24", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_24", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.9000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 760.4000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_522_generated", "manhole_dn": "manhole_523_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385831.554474999429658, 5858837.476550582796335 ], [ 1385834.933234154479578, 5858795.367517679929733 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_24_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_24", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_24", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 748.9000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_523_generated", "manhole_dn": "manhole_524_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385834.933234154479578, 5858795.367517679929733 ], [ 1385855.640895856311545, 5858836.135079927742481 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_25_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_25", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.79998779296875, "elevtn_dn": 791.20001220703125, "invlev_up": 784.29998779296875, "invlev_dn": 788.70001220703125, "manhole_up": "manhole_525_generated", "manhole_dn": "manhole_526_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385425.871741503709927, 5858809.522038951516151 ], [ 1385446.216239683330059, 5858844.397748519666493 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_25_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_25", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.20001220703125, "elevtn_dn": 791.20001220703125, "invlev_up": 788.70001220703125, "invlev_dn": 788.70001220703125, "manhole_up": "manhole_526_generated", "manhole_dn": "manhole_527_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385446.216239683330059, 5858844.397748519666493 ], [ 1385453.998638280900195, 5858886.437654017470777 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_25_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_25", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.20001220703125, "elevtn_dn": 783.0, "invlev_up": 788.70001220703125, "invlev_dn": 780.5, "manhole_up": "manhole_527_generated", "manhole_dn": "manhole_528_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385453.998638280900195, 5858886.437654017470777 ], [ 1385472.218053022632375, 5858925.273072509095073 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_26_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_26", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_26", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.9000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 760.4000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_522_generated", "manhole_dn": "manhole_524_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385831.554474999429658, 5858837.476550582796335 ], [ 1385855.640895856311545, 5858836.135079927742481 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_29_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_29", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_29", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_529_generated", "manhole_dn": "manhole_530_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385861.372513797832653, 5858893.832569030113518 ], [ 1385844.630084188189358, 5858865.848266057670116 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_29_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_29", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_29", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 762.9000244140625, "invlev_up": 757.20001220703125, "invlev_dn": 760.4000244140625, "manhole_up": "manhole_530_generated", "manhole_dn": "manhole_522_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385844.630084188189358, 5858865.848266057670116 ], [ 1385831.554474999429658, 5858837.476550582796335 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_30_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 769.4000244140625, "invlev_up": 766.9000244140625, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_531_generated", "manhole_dn": "manhole_532_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387137.22300889948383, 5858981.723106959834695 ], [ 1387148.04859330272302, 5859026.366797789931297 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_30_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 762.60003662109375, "invlev_up": 766.9000244140625, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_532_generated", "manhole_dn": "manhole_533_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387148.04859330272302, 5859026.366797789931297 ], [ 1387119.95937648974359, 5859056.934598693624139 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_30_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 762.60003662109375, "invlev_up": 760.10003662109375, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_533_generated", "manhole_dn": "manhole_534_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387119.95937648974359, 5859056.934598693624139 ], [ 1387074.832296247361228, 5859065.30100557859987 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_30_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 755.79998779296875, "invlev_up": 760.10003662109375, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_534_generated", "manhole_dn": "manhole_535_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387074.832296247361228, 5859065.30100557859987 ], [ 1387030.356415221933275, 5859076.86137125454843 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_30_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 772.4000244140625, "invlev_up": 753.29998779296875, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_535_generated", "manhole_dn": "manhole_536_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387030.356415221933275, 5859076.86137125454843 ], [ 1386986.427998587489128, 5859090.309648380614817 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_30_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 761.60003662109375, "invlev_up": 769.9000244140625, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_536_generated", "manhole_dn": "manhole_537_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386986.427998587489128, 5859090.309648380614817 ], [ 1386945.966695382725447, 5859111.788386604748666 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_30_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_537_generated", "manhole_dn": "manhole_538_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386945.966695382725447, 5859111.788386604748666 ], [ 1386905.77102447184734, 5859134.105928846634924 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_30_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_538_generated", "manhole_dn": "manhole_539_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386905.77102447184734, 5859134.105928846634924 ], [ 1386871.537448140559718, 5859162.609670763835311 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_539_generated", "manhole_dn": "manhole_540_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386871.537448140559718, 5859162.609670763835311 ], [ 1386921.106019288301468, 5859163.103915391489863 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 772.4000244140625, "invlev_up": 759.10003662109375, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_540_generated", "manhole_dn": "manhole_541_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386921.106019288301468, 5859163.103915391489863 ], [ 1386970.627896018791944, 5859161.624508504755795 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 772.4000244140625, "invlev_up": 769.9000244140625, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_541_generated", "manhole_dn": "manhole_542_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386970.627896018791944, 5859161.624508504755795 ], [ 1387019.993600395740941, 5859157.412991388700902 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 781.10003662109375, "invlev_up": 769.9000244140625, "invlev_dn": 778.60003662109375, "manhole_up": "manhole_542_generated", "manhole_dn": "manhole_543_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387019.993600395740941, 5859157.412991388700902 ], [ 1387069.191225855611265, 5859151.340004274621606 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 781.10003662109375, "elevtn_dn": 781.10003662109375, "invlev_up": 778.60003662109375, "invlev_dn": 778.60003662109375, "manhole_up": "manhole_543_generated", "manhole_dn": "manhole_544_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387069.191225855611265, 5859151.340004274621606 ], [ 1387118.547863835236058, 5859146.828392788767815 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 781.10003662109375, "elevtn_dn": 786.4000244140625, "invlev_up": 778.60003662109375, "invlev_dn": 783.9000244140625, "manhole_up": "manhole_544_generated", "manhole_dn": "manhole_545_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387118.547863835236058, 5859146.828392788767815 ], [ 1387167.916038708761334, 5859151.025294326245785 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.4000244140625, "elevtn_dn": 786.4000244140625, "invlev_up": 783.9000244140625, "invlev_dn": 783.9000244140625, "manhole_up": "manhole_545_generated", "manhole_dn": "manhole_546_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387167.916038708761334, 5859151.025294326245785 ], [ 1387217.282604865729809, 5859155.523034786805511 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.4000244140625, "elevtn_dn": 787.60003662109375, "invlev_up": 783.9000244140625, "invlev_dn": 785.10003662109375, "manhole_up": "manhole_546_generated", "manhole_dn": "manhole_547_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387217.282604865729809, 5859155.523034786805511 ], [ 1387266.649171022465453, 5859160.020775248296559 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.60003662109375, "elevtn_dn": 787.60003662109375, "invlev_up": 785.10003662109375, "invlev_dn": 785.10003662109375, "manhole_up": "manhole_547_generated", "manhole_dn": "manhole_548_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387266.649171022465453, 5859160.020775248296559 ], [ 1387315.831188223091885, 5859165.716172898188233 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.60003662109375, "elevtn_dn": 790.4000244140625, "invlev_up": 785.10003662109375, "invlev_dn": 787.9000244140625, "manhole_up": "manhole_548_generated", "manhole_dn": "manhole_549_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387315.831188223091885, 5859165.716172898188233 ], [ 1387364.261764668161049, 5859176.288154195994139 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 790.4000244140625, "elevtn_dn": 790.4000244140625, "invlev_up": 787.9000244140625, "invlev_dn": 787.9000244140625, "manhole_up": "manhole_549_generated", "manhole_dn": "manhole_550_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387364.261764668161049, 5859176.288154195994139 ], [ 1387411.186259990092367, 5859192.118345031514764 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 790.4000244140625, "elevtn_dn": 789.10003662109375, "invlev_up": 787.9000244140625, "invlev_dn": 786.60003662109375, "manhole_up": "manhole_550_generated", "manhole_dn": "manhole_551_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387411.186259990092367, 5859192.118345031514764 ], [ 1387455.544592748628929, 5859213.906051598489285 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 789.10003662109375, "elevtn_dn": 817.20001220703125, "invlev_up": 786.60003662109375, "invlev_dn": 814.70001220703125, "manhole_up": "manhole_551_generated", "manhole_dn": "manhole_552_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387455.544592748628929, 5859213.906051598489285 ], [ 1387490.610425172373652, 5859248.94134864397347 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 817.20001220703125, "elevtn_dn": 818.20001220703125, "invlev_up": 814.70001220703125, "invlev_dn": 815.70001220703125, "manhole_up": "manhole_552_generated", "manhole_dn": "manhole_553_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387490.610425172373652, 5859248.94134864397347 ], [ 1387525.979065561201423, 5859283.669168318621814 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.20001220703125, "elevtn_dn": 818.20001220703125, "invlev_up": 815.70001220703125, "invlev_dn": 815.70001220703125, "manhole_up": "manhole_553_generated", "manhole_dn": "manhole_554_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387525.979065561201423, 5859283.669168318621814 ], [ 1387563.532416822388768, 5859316.0270627560094 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.20001220703125, "elevtn_dn": 802.79998779296875, "invlev_up": 815.70001220703125, "invlev_dn": 800.29998779296875, "manhole_up": "manhole_554_generated", "manhole_dn": "manhole_555_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387563.532416822388768, 5859316.0270627560094 ], [ 1387601.085768083808944, 5859348.384957193396986 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.79998779296875, "elevtn_dn": 837.70001220703125, "invlev_up": 800.29998779296875, "invlev_dn": 835.20001220703125, "manhole_up": "manhole_555_generated", "manhole_dn": "manhole_556_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387601.085768083808944, 5859348.384957193396986 ], [ 1387638.639119345229119, 5859380.742851630784571 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 837.70001220703125, "elevtn_dn": 837.70001220703125, "invlev_up": 835.20001220703125, "invlev_dn": 835.20001220703125, "manhole_up": "manhole_556_generated", "manhole_dn": "manhole_557_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387638.639119345229119, 5859380.742851630784571 ], [ 1387676.192470606416464, 5859413.100746068172157 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 837.70001220703125, "elevtn_dn": 828.79998779296875, "invlev_up": 835.20001220703125, "invlev_dn": 826.29998779296875, "manhole_up": "manhole_557_generated", "manhole_dn": "manhole_558_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387676.192470606416464, 5859413.100746068172157 ], [ 1387713.745821867836639, 5859445.45864050462842 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 828.79998779296875, "elevtn_dn": 828.79998779296875, "invlev_up": 826.29998779296875, "invlev_dn": 826.29998779296875, "manhole_up": "manhole_558_generated", "manhole_dn": "manhole_559_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387713.745821867836639, 5859445.45864050462842 ], [ 1387750.394377880264074, 5859478.825171477161348 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 828.79998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 826.29998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_559_generated", "manhole_dn": "manhole_560_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387750.394377880264074, 5859478.825171477161348 ], [ 1387786.626276910537854, 5859512.656178202480078 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 851.79998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_560_generated", "manhole_dn": "manhole_561_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387786.626276910537854, 5859512.656178202480078 ], [ 1387822.858175940578803, 5859546.487184926867485 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 851.79998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_561_generated", "manhole_dn": "manhole_562_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387822.858175940578803, 5859546.487184926867485 ], [ 1387850.662340233800933, 5859586.980695966631174 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 891.20001220703125, "invlev_up": 851.79998779296875, "invlev_dn": 888.70001220703125, "manhole_up": "manhole_562_generated", "manhole_dn": "manhole_563_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387850.662340233800933, 5859586.980695966631174 ], [ 1387868.193221996771172, 5859633.330900657922029 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.20001220703125, "elevtn_dn": 876.20001220703125, "invlev_up": 888.70001220703125, "invlev_dn": 873.70001220703125, "manhole_up": "manhole_563_generated", "manhole_dn": "manhole_564_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387868.193221996771172, 5859633.330900657922029 ], [ 1387885.535610173596069, 5859679.769344814121723 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 876.20001220703125, "elevtn_dn": 876.20001220703125, "invlev_up": 873.70001220703125, "invlev_dn": 873.70001220703125, "manhole_up": "manhole_564_generated", "manhole_dn": "manhole_565_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387885.535610173596069, 5859679.769344814121723 ], [ 1387902.854485532967374, 5859726.216552678495646 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 876.20001220703125, "elevtn_dn": 898.29998779296875, "invlev_up": 873.70001220703125, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_565_generated", "manhole_dn": "manhole_566_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387902.854485532967374, 5859726.216552678495646 ], [ 1387920.137465380365029, 5859772.67713953461498 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 898.29998779296875, "invlev_up": 895.79998779296875, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_566_generated", "manhole_dn": "manhole_567_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387920.137465380365029, 5859772.67713953461498 ], [ 1387937.420445227529854, 5859819.137726389802992 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 898.29998779296875, "invlev_up": 895.79998779296875, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_567_generated", "manhole_dn": "manhole_568_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387937.420445227529854, 5859819.137726389802992 ], [ 1387948.863530882401392, 5859867.082766367122531 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 918.5, "invlev_up": 895.79998779296875, "invlev_dn": 916.0, "manhole_up": "manhole_568_generated", "manhole_dn": "manhole_569_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387948.863530882401392, 5859867.082766367122531 ], [ 1387950.013254075078294, 5859916.565449987538159 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 918.5, "invlev_up": 916.0, "invlev_dn": 916.0, "manhole_up": "manhole_569_generated", "manhole_dn": "manhole_570_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387950.013254075078294, 5859916.565449987538159 ], [ 1387947.430782878771424, 5859966.047936389222741 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 918.5, "invlev_up": 916.0, "invlev_dn": 916.0, "manhole_up": "manhole_570_generated", "manhole_dn": "manhole_571_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387947.430782878771424, 5859966.047936389222741 ], [ 1387943.997958281077445, 5860015.499966060742736 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 948.60003662109375, "invlev_up": 916.0, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_571_generated", "manhole_dn": "manhole_572_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387943.997958281077445, 5860015.499966060742736 ], [ 1387940.565133683150634, 5860064.951995733194053 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 948.60003662109375, "invlev_up": 946.10003662109375, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_572_generated", "manhole_dn": "manhole_573_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.565133683150634, 5860064.951995733194053 ], [ 1387945.371777657186612, 5860113.959104515612125 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 948.60003662109375, "invlev_up": 946.10003662109375, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_573_generated", "manhole_dn": "manhole_574_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387945.371777657186612, 5860113.959104515612125 ], [ 1387964.117816498270258, 5860159.736532494425774 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 940.5, "invlev_up": 946.10003662109375, "invlev_dn": 938.0, "manhole_up": "manhole_574_generated", "manhole_dn": "manhole_575_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387964.117816498270258, 5860159.736532494425774 ], [ 1387984.093857799191028, 5860205.104420888237655 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 940.5, "invlev_up": 938.0, "invlev_dn": 938.0, "manhole_up": "manhole_575_generated", "manhole_dn": "manhole_576_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387984.093857799191028, 5860205.104420888237655 ], [ 1388004.069899099878967, 5860250.472309282049537 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 940.5, "invlev_up": 938.0, "invlev_dn": 938.0, "manhole_up": "manhole_576_generated", "manhole_dn": "manhole_577_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388004.069899099878967, 5860250.472309282049537 ], [ 1388027.68692572391592, 5860293.896034284494817 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 971.70001220703125, "invlev_up": 938.0, "invlev_dn": 969.20001220703125, "manhole_up": "manhole_577_generated", "manhole_dn": "manhole_578_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388027.68692572391592, 5860293.896034284494817 ], [ 1388060.096315970877185, 5860331.348726416006684 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 971.70001220703125, "elevtn_dn": 935.5, "invlev_up": 969.20001220703125, "invlev_dn": 933.0, "manhole_up": "manhole_578_generated", "manhole_dn": "manhole_579_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388060.096315970877185, 5860331.348726416006684 ], [ 1388092.967688721138984, 5860368.453448176383972 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 935.5, "invlev_up": 933.0, "invlev_dn": 933.0, "manhole_up": "manhole_579_generated", "manhole_dn": "manhole_580_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388092.967688721138984, 5860368.453448176383972 ], [ 1388119.020827289205045, 5860410.510251956991851 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 949.9000244140625, "invlev_up": 933.0, "invlev_dn": 947.4000244140625, "manhole_up": "manhole_580_generated", "manhole_dn": "manhole_581_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388119.020827289205045, 5860410.510251956991851 ], [ 1388143.407622833969072, 5860453.667774203233421 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 949.9000244140625, "elevtn_dn": 924.60003662109375, "invlev_up": 947.4000244140625, "invlev_dn": 922.10003662109375, "manhole_up": "manhole_581_generated", "manhole_dn": "manhole_582_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388143.407622833969072, 5860453.667774203233421 ], [ 1388167.794418378733099, 5860496.82529644947499 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 924.60003662109375, "elevtn_dn": 924.60003662109375, "invlev_up": 922.10003662109375, "invlev_dn": 922.10003662109375, "manhole_up": "manhole_582_generated", "manhole_dn": "manhole_583_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388167.794418378733099, 5860496.82529644947499 ], [ 1388187.41186453984119, 5860542.097804954275489 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 924.60003662109375, "elevtn_dn": 942.4000244140625, "invlev_up": 922.10003662109375, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_583_generated", "manhole_dn": "manhole_584_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388187.41186453984119, 5860542.097804954275489 ], [ 1388193.385166377527639, 5860591.251542154699564 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 942.4000244140625, "invlev_up": 939.9000244140625, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_584_generated", "manhole_dn": "manhole_585_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388193.385166377527639, 5860591.251542154699564 ], [ 1388198.812296225922182, 5860640.524595490656793 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 942.4000244140625, "invlev_up": 939.9000244140625, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_585_generated", "manhole_dn": "manhole_586_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388198.812296225922182, 5860640.524595490656793 ], [ 1388204.239426074549556, 5860689.7976488256827 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 955.0, "invlev_up": 939.9000244140625, "invlev_dn": 952.5, "manhole_up": "manhole_586_generated", "manhole_dn": "manhole_587_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388204.239426074549556, 5860689.7976488256827 ], [ 1388184.484932377934456, 5860730.700381714850664 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E48", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_587_generated", "manhole_dn": "manhole_588_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388184.484932377934456, 5860730.700381714850664 ], [ 1388159.550175313837826, 5860759.392759991809726 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E49", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_588_generated", "manhole_dn": "manhole_589_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388159.550175313837826, 5860759.392759991809726 ], [ 1388171.988544700434431, 5860807.377908634953201 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E50", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_589_generated", "manhole_dn": "manhole_590_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388171.988544700434431, 5860807.377908634953201 ], [ 1388215.013825689908117, 5860825.214942933060229 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E51", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 941.10003662109375, "invlev_up": 952.5, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_590_generated", "manhole_dn": "manhole_591_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388215.013825689908117, 5860825.214942933060229 ], [ 1388264.397385431453586, 5860829.298032846301794 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E52", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_591_generated", "manhole_dn": "manhole_592_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388264.397385431453586, 5860829.298032846301794 ], [ 1388313.062299854354933, 5860837.304878970608115 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E53", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 937.5, "invlev_up": 938.60003662109375, "invlev_dn": 935.0, "manhole_up": "manhole_592_generated", "manhole_dn": "manhole_593_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388313.062299854354933, 5860837.304878970608115 ], [ 1388360.993895401246846, 5860849.948045967146754 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E54", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.5, "elevtn_dn": 937.5, "invlev_up": 935.0, "invlev_dn": 935.0, "manhole_up": "manhole_593_generated", "manhole_dn": "manhole_594_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388360.993895401246846, 5860849.948045967146754 ], [ 1388408.925490947905928, 5860862.591212964616716 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E55", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.5, "elevtn_dn": 937.60003662109375, "invlev_up": 935.0, "invlev_dn": 935.10003662109375, "manhole_up": "manhole_594_generated", "manhole_dn": "manhole_595_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388408.925490947905928, 5860862.591212964616716 ], [ 1388458.220990223577246, 5860866.957201769575477 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E56", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.60003662109375, "elevtn_dn": 937.60003662109375, "invlev_up": 935.10003662109375, "invlev_dn": 935.10003662109375, "manhole_up": "manhole_595_generated", "manhole_dn": "manhole_596_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388458.220990223577246, 5860866.957201769575477 ], [ 1388507.336333080893382, 5860873.218384950421751 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E57", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.60003662109375, "elevtn_dn": 941.20001220703125, "invlev_up": 935.10003662109375, "invlev_dn": 938.70001220703125, "manhole_up": "manhole_596_generated", "manhole_dn": "manhole_597_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388507.336333080893382, 5860873.218384950421751 ], [ 1388556.215695114107803, 5860881.470384138636291 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E58", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.20001220703125, "elevtn_dn": 941.20001220703125, "invlev_up": 938.70001220703125, "invlev_dn": 938.70001220703125, "manhole_up": "manhole_597_generated", "manhole_dn": "manhole_598_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388556.215695114107803, 5860881.470384138636291 ], [ 1388604.556662159739062, 5860892.361969010904431 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E59", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.20001220703125, "elevtn_dn": 943.10003662109375, "invlev_up": 938.70001220703125, "invlev_dn": 940.60003662109375, "manhole_up": "manhole_598_generated", "manhole_dn": "manhole_599_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388604.556662159739062, 5860892.361969010904431 ], [ 1388653.59940263046883, 5860897.15789801068604 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E60", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 943.10003662109375, "elevtn_dn": 943.10003662109375, "invlev_up": 940.60003662109375, "invlev_dn": 940.60003662109375, "manhole_up": "manhole_599_generated", "manhole_dn": "manhole_600_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388653.59940263046883, 5860897.15789801068604 ], [ 1388700.080393208190799, 5860881.090511013753712 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E61", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 943.10003662109375, "elevtn_dn": 946.10003662109375, "invlev_up": 940.60003662109375, "invlev_dn": 943.60003662109375, "manhole_up": "manhole_600_generated", "manhole_dn": "manhole_601_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388700.080393208190799, 5860881.090511013753712 ], [ 1388732.687003659084439, 5860844.794781206175685 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E62", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 946.10003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 943.60003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_601_generated", "manhole_dn": "manhole_602_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388732.687003659084439, 5860844.794781206175685 ], [ 1388755.953327334951609, 5860801.023035684600472 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E63", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 950.10003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_602_generated", "manhole_dn": "manhole_603_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388755.953327334951609, 5860801.023035684600472 ], [ 1388778.23369869007729, 5860756.84024004638195 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E64", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 950.10003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_603_generated", "manhole_dn": "manhole_604_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388778.23369869007729, 5860756.84024004638195 ], [ 1388792.950793598080054, 5860709.504263866692781 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E65", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 953.79998779296875, "invlev_up": 950.10003662109375, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_604_generated", "manhole_dn": "manhole_605_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388792.950793598080054, 5860709.504263866692781 ], [ 1388807.667888506315649, 5860662.168287687934935 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E66", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_605_generated", "manhole_dn": "manhole_606_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388807.667888506315649, 5860662.168287687934935 ], [ 1388819.224422588944435, 5860613.968191100284457 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E67", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 955.70001220703125, "invlev_up": 951.29998779296875, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_606_generated", "manhole_dn": "manhole_607_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388819.224422588944435, 5860613.968191100284457 ], [ 1388830.63825476472266, 5860565.72907877061516 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E68", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_607_generated", "manhole_dn": "manhole_608_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388830.63825476472266, 5860565.72907877061516 ], [ 1388842.052086940500885, 5860517.489966440014541 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E69", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_608_generated", "manhole_dn": "manhole_609_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388842.052086940500885, 5860517.489966440014541 ], [ 1388862.77624000934884, 5860472.578981296159327 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E70", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 964.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_609_generated", "manhole_dn": "manhole_610_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388862.77624000934884, 5860472.578981296159327 ], [ 1388884.529400010826066, 5860428.03588358964771 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E71", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 951.29998779296875, "invlev_up": 962.20001220703125, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_610_generated", "manhole_dn": "manhole_611_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388884.529400010826066, 5860428.03588358964771 ], [ 1388906.282637836178765, 5860383.492823889479041 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E72", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_611_generated", "manhole_dn": "manhole_612_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388906.282637836178765, 5860383.492823889479041 ], [ 1388933.946375871310011, 5860342.419800435192883 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E73", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_612_generated", "manhole_dn": "manhole_613_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388933.946375871310011, 5860342.419800435192883 ], [ 1388962.240715913940221, 5860301.717001453973353 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_33_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 752.29998779296875, "invlev_up": 759.10003662109375, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_539_generated", "manhole_dn": "manhole_614_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386871.537448140559718, 5859162.609670763835311 ], [ 1386825.19834817154333, 5859175.156894122250378 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_33_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 752.29998779296875, "invlev_up": 749.79998779296875, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_614_generated", "manhole_dn": "manhole_615_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386825.19834817154333, 5859175.156894122250378 ], [ 1386779.333999397465959, 5859189.44842192158103 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_33_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 738.0, "invlev_up": 749.79998779296875, "invlev_dn": 735.5, "manhole_up": "manhole_615_generated", "manhole_dn": "manhole_616_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386779.333999397465959, 5859189.44842192158103 ], [ 1386733.445003136992455, 5859203.660136871039867 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_33_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 738.0, "invlev_up": 735.5, "invlev_dn": 735.5, "manhole_up": "manhole_616_generated", "manhole_dn": "manhole_617_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386733.445003136992455, 5859203.660136871039867 ], [ 1386687.508546756347641, 5859217.718167688697577 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_33_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 763.29998779296875, "invlev_up": 735.5, "invlev_dn": 760.79998779296875, "manhole_up": "manhole_617_generated", "manhole_dn": "manhole_618_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386687.508546756347641, 5859217.718167688697577 ], [ 1386641.572090375469998, 5859231.776198507286608 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_33_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 763.29998779296875, "elevtn_dn": 763.29998779296875, "invlev_up": 760.79998779296875, "invlev_dn": 760.79998779296875, "manhole_up": "manhole_618_generated", "manhole_dn": "manhole_619_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386641.572090375469998, 5859231.776198507286608 ], [ 1386595.451642262749374, 5859245.168246414512396 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_33_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 763.29998779296875, "elevtn_dn": 754.60003662109375, "invlev_up": 760.79998779296875, "invlev_dn": 752.10003662109375, "manhole_up": "manhole_619_generated", "manhole_dn": "manhole_620_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386595.451642262749374, 5859245.168246414512396 ], [ 1386548.813360751140863, 5859256.685926430858672 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_33_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.60003662109375, "elevtn_dn": 754.60003662109375, "invlev_up": 752.10003662109375, "invlev_dn": 752.10003662109375, "manhole_up": "manhole_620_generated", "manhole_dn": "manhole_621_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386548.813360751140863, 5859256.685926430858672 ], [ 1386502.175079239532351, 5859268.203606447204947 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_33_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.60003662109375, "elevtn_dn": 742.5, "invlev_up": 752.10003662109375, "invlev_dn": 740.0, "manhole_up": "manhole_621_generated", "manhole_dn": "manhole_622_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386502.175079239532351, 5859268.203606447204947 ], [ 1386455.354356503346935, 5859278.943273726850748 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_33_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 742.5, "invlev_up": 740.0, "invlev_dn": 740.0, "manhole_up": "manhole_622_generated", "manhole_dn": "manhole_623_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386455.354356503346935, 5859278.943273726850748 ], [ 1386408.879239794565365, 5859290.671229789964855 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_33_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 717.60003662109375, "invlev_up": 740.0, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_623_generated", "manhole_dn": "manhole_624_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386408.879239794565365, 5859290.671229789964855 ], [ 1386364.691368696978316, 5859309.518465746194124 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_33_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 717.60003662109375, "invlev_up": 715.10003662109375, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_624_generated", "manhole_dn": "manhole_625_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386364.691368696978316, 5859309.518465746194124 ], [ 1386320.503497599391267, 5859328.365701701492071 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_33_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 711.0, "invlev_up": 715.10003662109375, "invlev_dn": 708.5, "manhole_up": "manhole_625_generated", "manhole_dn": "manhole_626_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386320.503497599391267, 5859328.365701701492071 ], [ 1386273.173811787506565, 5859335.36546028777957 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 953.70001220703125, "invlev_up": 948.79998779296875, "invlev_dn": 951.20001220703125, "manhole_up": "manhole_10_generated", "manhole_dn": "manhole_627_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388946.301100668497384, 5860414.883977899327874 ], [ 1388922.246059404918924, 5860458.418739438988268 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.70001220703125, "elevtn_dn": 953.70001220703125, "invlev_up": 951.20001220703125, "invlev_dn": 951.20001220703125, "manhole_up": "manhole_627_generated", "manhole_dn": "manhole_628_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388922.246059404918924, 5860458.418739438988268 ], [ 1388900.295977992936969, 5860503.075897979550064 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 951.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_628_generated", "manhole_dn": "manhole_629_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388900.295977992936969, 5860503.075897979550064 ], [ 1388878.345896581187844, 5860547.733056520111859 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 953.79998779296875, "invlev_up": 953.20001220703125, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_629_generated", "manhole_dn": "manhole_630_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388878.345896581187844, 5860547.733056520111859 ], [ 1388856.887740465346724, 5860592.570927501656115 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_630_generated", "manhole_dn": "manhole_631_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388856.887740465346724, 5860592.570927501656115 ], [ 1388853.076019846601412, 5860641.795407227240503 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_631_generated", "manhole_dn": "manhole_632_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388853.076019846601412, 5860641.795407227240503 ], [ 1388856.119826921960339, 5860691.462329030036926 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 952.5, "invlev_up": 951.29998779296875, "invlev_dn": 950.0, "manhole_up": "manhole_632_generated", "manhole_dn": "manhole_633_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388856.119826921960339, 5860691.462329030036926 ], [ 1388859.163633997086436, 5860741.12925083283335 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.5, "elevtn_dn": 952.5, "invlev_up": 950.0, "invlev_dn": 950.0, "manhole_up": "manhole_633_generated", "manhole_dn": "manhole_634_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388859.163633997086436, 5860741.12925083283335 ], [ 1388862.207441072445363, 5860790.796172635629773 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.5, "elevtn_dn": 945.5, "invlev_up": 950.0, "invlev_dn": 943.0, "manhole_up": "manhole_634_generated", "manhole_dn": "manhole_635_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388862.207441072445363, 5860790.796172635629773 ], [ 1388866.356326055014506, 5860840.344227194786072 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 945.5, "invlev_up": 943.0, "invlev_dn": 943.0, "manhole_up": "manhole_635_generated", "manhole_dn": "manhole_636_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388866.356326055014506, 5860840.344227194786072 ], [ 1388873.944740658160299, 5860889.522310186177492 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 945.5, "invlev_up": 943.0, "invlev_dn": 943.0, "manhole_up": "manhole_636_generated", "manhole_dn": "manhole_637_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388873.944740658160299, 5860889.522310186177492 ], [ 1388883.17427325528115, 5860938.398467163555324 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 937.4000244140625, "invlev_up": 943.0, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_637_generated", "manhole_dn": "manhole_638_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388883.17427325528115, 5860938.398467163555324 ], [ 1388890.216840920504183, 5860987.212368851527572 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 937.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_638_generated", "manhole_dn": "manhole_639_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388890.216840920504183, 5860987.212368851527572 ], [ 1388884.322194910608232, 5861036.62209493201226 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 937.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_639_generated", "manhole_dn": "manhole_640_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388884.322194910608232, 5861036.62209493201226 ], [ 1388878.427548900712281, 5861086.031821011565626 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_640_generated", "manhole_dn": "manhole_641_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388878.427548900712281, 5861086.031821011565626 ], [ 1388872.532902890816331, 5861135.441547092050314 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 927.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_641_generated", "manhole_dn": "manhole_642_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388872.532902890816331, 5861135.441547092050314 ], [ 1388866.63825688092038, 5861184.851273172535002 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 927.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_642_generated", "manhole_dn": "manhole_643_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388866.63825688092038, 5861184.851273172535002 ], [ 1388854.620840607210994, 5861232.489912945777178 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 926.60003662109375, "invlev_up": 927.9000244140625, "invlev_dn": 924.10003662109375, "manhole_up": "manhole_643_generated", "manhole_dn": "manhole_644_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388854.620840607210994, 5861232.489912945777178 ], [ 1388833.22756120422855, 5861277.416469449177384 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 926.60003662109375, "elevtn_dn": 926.60003662109375, "invlev_up": 924.10003662109375, "invlev_dn": 924.10003662109375, "manhole_up": "manhole_644_generated", "manhole_dn": "manhole_645_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388833.22756120422855, 5861277.416469449177384 ], [ 1388811.834281801246107, 5861322.343025953508914 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 926.60003662109375, "elevtn_dn": 931.10003662109375, "invlev_up": 924.10003662109375, "invlev_dn": 928.60003662109375, "manhole_up": "manhole_645_generated", "manhole_dn": "manhole_646_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388811.834281801246107, 5861322.343025953508914 ], [ 1388790.441002398030832, 5861367.26958245690912 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 931.10003662109375, "elevtn_dn": 922.20001220703125, "invlev_up": 928.60003662109375, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_646_generated", "manhole_dn": "manhole_647_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388790.441002398030832, 5861367.26958245690912 ], [ 1388769.047722995048389, 5861412.196138960309327 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 922.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_647_generated", "manhole_dn": "manhole_648_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388769.047722995048389, 5861412.196138960309327 ], [ 1388747.654443592065945, 5861457.122695464640856 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 922.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_648_generated", "manhole_dn": "manhole_649_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388747.654443592065945, 5861457.122695464640856 ], [ 1388725.026126575190574, 5861501.410491958260536 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_649_generated", "manhole_dn": "manhole_650_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388725.026126575190574, 5861501.410491958260536 ], [ 1388700.725248141447082, 5861544.833241644315422 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_650_generated", "manhole_dn": "manhole_651_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388700.725248141447082, 5861544.833241644315422 ], [ 1388676.42436970770359, 5861588.255991329438984 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_651_generated", "manhole_dn": "manhole_652_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388676.42436970770359, 5861588.255991329438984 ], [ 1388632.324464634526521, 5861606.441272142343223 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 898.4000244140625, "invlev_up": 897.70001220703125, "invlev_dn": 895.9000244140625, "manhole_up": "manhole_652_generated", "manhole_dn": "manhole_653_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388632.324464634526521, 5861606.441272142343223 ], [ 1388583.463808472501114, 5861611.105615227483213 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.4000244140625, "elevtn_dn": 898.4000244140625, "invlev_up": 895.9000244140625, "invlev_dn": 895.9000244140625, "manhole_up": "manhole_653_generated", "manhole_dn": "manhole_654_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388583.463808472501114, 5861611.105615227483213 ], [ 1388534.764012826373801, 5861604.222017968073487 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.4000244140625, "elevtn_dn": 903.60003662109375, "invlev_up": 895.9000244140625, "invlev_dn": 901.10003662109375, "manhole_up": "manhole_654_generated", "manhole_dn": "manhole_655_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388534.764012826373801, 5861604.222017968073487 ], [ 1388489.566489090910181, 5861583.40731808822602 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 903.60003662109375, "elevtn_dn": 903.60003662109375, "invlev_up": 901.10003662109375, "invlev_dn": 901.10003662109375, "manhole_up": "manhole_655_generated", "manhole_dn": "manhole_656_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388489.566489090910181, 5861583.40731808822602 ], [ 1388444.204915680922568, 5861563.162508152425289 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 903.60003662109375, "elevtn_dn": 906.4000244140625, "invlev_up": 901.10003662109375, "invlev_dn": 903.9000244140625, "manhole_up": "manhole_656_generated", "manhole_dn": "manhole_657_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388444.204915680922568, 5861563.162508152425289 ], [ 1388394.858231473481283, 5861556.761520680040121 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 906.4000244140625, "elevtn_dn": 906.4000244140625, "invlev_up": 903.9000244140625, "invlev_dn": 903.9000244140625, "manhole_up": "manhole_657_generated", "manhole_dn": "manhole_658_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388394.858231473481283, 5861556.761520680040121 ], [ 1388350.680838279658929, 5861570.408674017526209 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 906.4000244140625, "elevtn_dn": 900.20001220703125, "invlev_up": 903.9000244140625, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_658_generated", "manhole_dn": "manhole_659_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388350.680838279658929, 5861570.408674017526209 ], [ 1388310.581732882419601, 5861599.872713611461222 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_659_generated", "manhole_dn": "manhole_660_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388310.581732882419601, 5861599.872713611461222 ], [ 1388271.039625711739063, 5861629.969603477045894 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 890.0, "invlev_up": 897.70001220703125, "invlev_dn": 887.5, "manhole_up": "manhole_660_generated", "manhole_dn": "manhole_661_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388271.039625711739063, 5861629.969603477045894 ], [ 1388236.722210306907073, 5861666.002683873288333 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 890.0, "invlev_up": 887.5, "invlev_dn": 887.5, "manhole_up": "manhole_661_generated", "manhole_dn": "manhole_662_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388236.722210306907073, 5861666.002683873288333 ], [ 1388202.404794902307913, 5861702.035764269530773 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 890.0, "invlev_up": 887.5, "invlev_dn": 887.5, "manhole_up": "manhole_662_generated", "manhole_dn": "manhole_663_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388202.404794902307913, 5861702.035764269530773 ], [ 1388168.087379497475922, 5861738.068844665773213 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 885.9000244140625, "invlev_up": 887.5, "invlev_dn": 883.4000244140625, "manhole_up": "manhole_663_generated", "manhole_dn": "manhole_664_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388168.087379497475922, 5861738.068844665773213 ], [ 1388133.769964092643932, 5861774.101925062015653 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 885.9000244140625, "elevtn_dn": 874.0, "invlev_up": 883.4000244140625, "invlev_dn": 871.5, "manhole_up": "manhole_664_generated", "manhole_dn": "manhole_665_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388133.769964092643932, 5861774.101925062015653 ], [ 1388099.452548687811941, 5861810.13500545732677 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 874.0, "elevtn_dn": 874.0, "invlev_up": 871.5, "invlev_dn": 871.5, "manhole_up": "manhole_665_generated", "manhole_dn": "manhole_666_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388099.452548687811941, 5861810.13500545732677 ], [ 1388065.135133283212781, 5861846.16808585356921 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 874.0, "elevtn_dn": 862.20001220703125, "invlev_up": 871.5, "invlev_dn": 859.70001220703125, "manhole_up": "manhole_666_generated", "manhole_dn": "manhole_667_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388065.135133283212781, 5861846.16808585356921 ], [ 1388022.995196633273736, 5861866.899685021489859 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 862.20001220703125, "elevtn_dn": 862.20001220703125, "invlev_up": 859.70001220703125, "invlev_dn": 859.70001220703125, "manhole_up": "manhole_667_generated", "manhole_dn": "manhole_668_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388022.995196633273736, 5861866.899685021489859 ], [ 1387973.690499771386385, 5861873.616436487063766 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 862.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 859.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_668_generated", "manhole_dn": "manhole_669_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387973.690499771386385, 5861873.616436487063766 ], [ 1387924.470484273741022, 5861880.90659652557224 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_669_generated", "manhole_dn": "manhole_670_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387924.470484273741022, 5861880.90659652557224 ], [ 1387877.962616891367361, 5861896.157046243548393 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_670_generated", "manhole_dn": "manhole_671_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387877.962616891367361, 5861896.157046243548393 ], [ 1387917.070526217576116, 5861911.915829903446138 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_671_generated", "manhole_dn": "manhole_672_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387917.070526217576116, 5861911.915829903446138 ], [ 1387966.654667611001059, 5861916.096835186704993 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 846.29998779296875, "invlev_up": 856.70001220703125, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_672_generated", "manhole_dn": "manhole_673_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387966.654667611001059, 5861916.096835186704993 ], [ 1388016.318005530629307, 5861919.063731476664543 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 850.10003662109375, "invlev_up": 843.79998779296875, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_673_generated", "manhole_dn": "manhole_674_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388016.318005530629307, 5861919.063731476664543 ], [ 1388066.025120510486886, 5861921.359510923735797 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E48", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 850.10003662109375, "invlev_up": 847.60003662109375, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_674_generated", "manhole_dn": "manhole_675_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388066.025120510486886, 5861921.359510923735797 ], [ 1388115.732235490344465, 5861923.655290370807052 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E49", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 849.0, "invlev_up": 847.60003662109375, "invlev_dn": 846.5, "manhole_up": "manhole_675_generated", "manhole_dn": "manhole_676_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388115.732235490344465, 5861923.655290370807052 ], [ 1388161.130695321131498, 5861931.457672152668238 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E50", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 849.0, "elevtn_dn": 850.10003662109375, "invlev_up": 846.5, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_676_generated", "manhole_dn": "manhole_677_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388161.130695321131498, 5861931.457672152668238 ], [ 1388139.871223766123876, 5861964.082641129381955 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E51", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 850.10003662109375, "invlev_up": 847.60003662109375, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_677_generated", "manhole_dn": "manhole_678_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388139.871223766123876, 5861964.082641129381955 ], [ 1388090.726845995755866, 5861957.769498392008245 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E52", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 846.29998779296875, "invlev_up": 847.60003662109375, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_678_generated", "manhole_dn": "manhole_679_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388090.726845995755866, 5861957.769498392008245 ], [ 1388049.339104855433106, 5861983.736727176234126 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E53", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 846.29998779296875, "invlev_up": 843.79998779296875, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_679_generated", "manhole_dn": "manhole_680_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388049.339104855433106, 5861983.736727176234126 ], [ 1388024.713075590552762, 5862026.975905770435929 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E54", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 846.29998779296875, "invlev_up": 843.79998779296875, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_680_generated", "manhole_dn": "manhole_681_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388024.713075590552762, 5862026.975905770435929 ], [ 1387980.016218039905652, 5862047.702198376879096 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E55", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 793.5, "invlev_up": 843.79998779296875, "invlev_dn": 791.0, "manhole_up": "manhole_681_generated", "manhole_dn": "manhole_682_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387980.016218039905652, 5862047.702198376879096 ], [ 1387931.90673128189519, 5862056.853296543471515 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E56", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.5, "elevtn_dn": 793.5, "invlev_up": 791.0, "invlev_dn": 791.0, "manhole_up": "manhole_682_generated", "manhole_dn": "manhole_683_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387931.90673128189519, 5862056.853296543471515 ], [ 1387882.187313467729837, 5862058.865105460397899 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E57", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.5, "elevtn_dn": 793.20001220703125, "invlev_up": 791.0, "invlev_dn": 790.70001220703125, "manhole_up": "manhole_683_generated", "manhole_dn": "manhole_684_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387882.187313467729837, 5862058.865105460397899 ], [ 1387832.722497318405658, 5862057.3410848621279 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E58", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.20001220703125, "elevtn_dn": 830.29998779296875, "invlev_up": 790.70001220703125, "invlev_dn": 827.79998779296875, "manhole_up": "manhole_684_generated", "manhole_dn": "manhole_685_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387832.722497318405658, 5862057.3410848621279 ], [ 1387783.80423084856011, 5862048.226750630885363 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E59", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.29998779296875, "elevtn_dn": 817.70001220703125, "invlev_up": 827.79998779296875, "invlev_dn": 815.20001220703125, "manhole_up": "manhole_685_generated", "manhole_dn": "manhole_686_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387783.80423084856011, 5862048.226750630885363 ], [ 1387734.885964378714561, 5862039.112416399642825 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E60", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 817.70001220703125, "elevtn_dn": 813.70001220703125, "invlev_up": 815.20001220703125, "invlev_dn": 811.20001220703125, "manhole_up": "manhole_686_generated", "manhole_dn": "manhole_687_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387734.885964378714561, 5862039.112416399642825 ], [ 1387685.967697908869013, 5862029.998082168400288 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E61", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 813.70001220703125, "elevtn_dn": 813.70001220703125, "invlev_up": 811.20001220703125, "invlev_dn": 811.20001220703125, "manhole_up": "manhole_687_generated", "manhole_dn": "manhole_688_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387685.967697908869013, 5862029.998082168400288 ], [ 1387637.036115845199674, 5862020.957140567712486 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E62", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 813.70001220703125, "elevtn_dn": 807.0, "invlev_up": 811.20001220703125, "invlev_dn": 804.5, "manhole_up": "manhole_688_generated", "manhole_dn": "manhole_689_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387637.036115845199674, 5862020.957140567712486 ], [ 1387588.033849656581879, 5862012.305794355459511 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E63", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.0, "elevtn_dn": 807.0, "invlev_up": 804.5, "invlev_dn": 804.5, "manhole_up": "manhole_689_generated", "manhole_dn": "manhole_690_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387588.033849656581879, 5862012.305794355459511 ], [ 1387539.031583468196914, 5862003.654448143206537 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E64", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.0, "elevtn_dn": 793.10003662109375, "invlev_up": 804.5, "invlev_dn": 790.60003662109375, "manhole_up": "manhole_690_generated", "manhole_dn": "manhole_691_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387539.031583468196914, 5862003.654448143206537 ], [ 1387490.029317279579118, 5861995.003101930953562 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E65", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.10003662109375, "elevtn_dn": 793.10003662109375, "invlev_up": 790.60003662109375, "invlev_dn": 790.60003662109375, "manhole_up": "manhole_691_generated", "manhole_dn": "manhole_692_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387490.029317279579118, 5861995.003101930953562 ], [ 1387440.720367865404114, 5861989.908138634636998 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E66", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.10003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 790.60003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_692_generated", "manhole_dn": "manhole_693_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387440.720367865404114, 5861989.908138634636998 ], [ 1387390.960446665296331, 5861990.042768024839461 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E67", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_693_generated", "manhole_dn": "manhole_694_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387390.960446665296331, 5861990.042768024839461 ], [ 1387341.200525465421379, 5861990.177397414110601 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E68", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 749.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 747.10003662109375, "manhole_up": "manhole_694_generated", "manhole_dn": "manhole_695_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387341.200525465421379, 5861990.177397414110601 ], [ 1387291.440604265546426, 5861990.312026804313064 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E69", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 749.60003662109375, "elevtn_dn": 749.60003662109375, "invlev_up": 747.10003662109375, "invlev_dn": 747.10003662109375, "manhole_up": "manhole_695_generated", "manhole_dn": "manhole_696_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387291.440604265546426, 5861990.312026804313064 ], [ 1387246.706285298336297, 5861974.212805554270744 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E70", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 749.60003662109375, "elevtn_dn": 747.0, "invlev_up": 747.10003662109375, "invlev_dn": 744.5, "manhole_up": "manhole_696_generated", "manhole_dn": "manhole_697_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387246.706285298336297, 5861974.212805554270744 ], [ 1387205.725988702848554, 5861945.987228964455426 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E71", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.0, "elevtn_dn": 771.79998779296875, "invlev_up": 744.5, "invlev_dn": 769.29998779296875, "manhole_up": "manhole_697_generated", "manhole_dn": "manhole_698_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387205.725988702848554, 5861945.987228964455426 ], [ 1387164.745692107127979, 5861917.761652374640107 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E72", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.79998779296875, "elevtn_dn": 764.10003662109375, "invlev_up": 769.29998779296875, "invlev_dn": 761.60003662109375, "manhole_up": "manhole_698_generated", "manhole_dn": "manhole_699_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387164.745692107127979, 5861917.761652374640107 ], [ 1387115.569933785125613, 5861911.215812381356955 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E73", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.10003662109375, "elevtn_dn": 764.10003662109375, "invlev_up": 761.60003662109375, "invlev_dn": 761.60003662109375, "manhole_up": "manhole_699_generated", "manhole_dn": "manhole_700_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387115.569933785125613, 5861911.215812381356955 ], [ 1387066.165866439929232, 5861905.273926095105708 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E74", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.10003662109375, "elevtn_dn": 747.70001220703125, "invlev_up": 761.60003662109375, "invlev_dn": 745.20001220703125, "manhole_up": "manhole_700_generated", "manhole_dn": "manhole_701_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387066.165866439929232, 5861905.273926095105708 ], [ 1387016.666836149292067, 5861900.238133460283279 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E75", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.70001220703125, "elevtn_dn": 747.70001220703125, "invlev_up": 745.20001220703125, "invlev_dn": 745.20001220703125, "manhole_up": "manhole_701_generated", "manhole_dn": "manhole_702_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387016.666836149292067, 5861900.238133460283279 ], [ 1386975.698310127714649, 5861874.842493440955877 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E76", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.70001220703125, "elevtn_dn": 739.60003662109375, "invlev_up": 745.20001220703125, "invlev_dn": 737.10003662109375, "manhole_up": "manhole_702_generated", "manhole_dn": "manhole_703_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386975.698310127714649, 5861874.842493440955877 ], [ 1386937.286019780673087, 5861843.21080310922116 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E77", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.60003662109375, "elevtn_dn": 739.60003662109375, "invlev_up": 737.10003662109375, "invlev_dn": 737.10003662109375, "manhole_up": "manhole_703_generated", "manhole_dn": "manhole_704_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386937.286019780673087, 5861843.21080310922116 ], [ 1386898.873729433864355, 5861811.579112778417766 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E78", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.60003662109375, "elevtn_dn": 755.20001220703125, "invlev_up": 737.10003662109375, "invlev_dn": 752.70001220703125, "manhole_up": "manhole_704_generated", "manhole_dn": "manhole_705_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386898.873729433864355, 5861811.579112778417766 ], [ 1386860.461439087055624, 5861779.947422447614372 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E79", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.20001220703125, "elevtn_dn": 745.29998779296875, "invlev_up": 752.70001220703125, "invlev_dn": 742.79998779296875, "manhole_up": "manhole_705_generated", "manhole_dn": "manhole_706_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386860.461439087055624, 5861779.947422447614372 ], [ 1386822.049148740014061, 5861748.315732115879655 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E80", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 745.29998779296875, "elevtn_dn": 745.29998779296875, "invlev_up": 742.79998779296875, "invlev_dn": 742.79998779296875, "manhole_up": "manhole_706_generated", "manhole_dn": "manhole_707_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386822.049148740014061, 5861748.315732115879655 ], [ 1386774.418702265014872, 5861733.958941764198244 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E81", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 745.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 742.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_707_generated", "manhole_dn": "manhole_708_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386774.418702265014872, 5861733.958941764198244 ], [ 1386726.75721522886306, 5861719.660321676172316 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E82", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_708_generated", "manhole_dn": "manhole_709_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386726.75721522886306, 5861719.660321676172316 ], [ 1386681.211287560872734, 5861700.510515534318984 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E83", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 777.9000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_709_generated", "manhole_dn": "manhole_710_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386681.211287560872734, 5861700.510515534318984 ], [ 1386655.081909105414525, 5861659.807657876051962 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E84", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 758.79998779296875, "invlev_up": 775.4000244140625, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_710_generated", "manhole_dn": "manhole_711_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386655.081909105414525, 5861659.807657876051962 ], [ 1386647.41175345890224, 5861610.757949161343277 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E85", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_711_generated", "manhole_dn": "manhole_712_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386647.41175345890224, 5861610.757949161343277 ], [ 1386641.745189253240824, 5861561.363539570011199 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E86", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 732.4000244140625, "invlev_up": 756.29998779296875, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_712_generated", "manhole_dn": "manhole_713_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386641.745189253240824, 5861561.363539570011199 ], [ 1386642.37134926696308, 5861511.607376066967845 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E87", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_713_generated", "manhole_dn": "manhole_714_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386642.37134926696308, 5861511.607376066967845 ], [ 1386642.997509280918166, 5861461.851212563924491 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E88", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_714_generated", "manhole_dn": "manhole_715_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386642.997509280918166, 5861461.851212563924491 ], [ 1386643.623669294640422, 5861412.09504906181246 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E89", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 724.29998779296875, "invlev_up": 729.9000244140625, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_715_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386643.623669294640422, 5861412.09504906181246 ], [ 1386648.271799877518788, 5861347.644815167412162 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_35_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_35", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_35", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_716_generated", "manhole_dn": "manhole_717_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386060.978602184914052, 5859873.390328846871853 ], [ 1386078.54455375042744, 5859857.065600479952991 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_35_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_35", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_35", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_717_generated", "manhole_dn": "manhole_718_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386078.54455375042744, 5859857.065600479952991 ], [ 1386079.86695942771621, 5859885.500408614054322 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_36_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_36", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_36", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_719_generated", "manhole_dn": "manhole_716_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386030.926458492642269, 5859869.881591100245714 ], [ 1386060.978602184914052, 5859873.390328846871853 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_37_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_37", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_37", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_720_generated", "manhole_dn": "manhole_716_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386043.381105761509389, 5859908.11929196305573 ], [ 1386060.978602184914052, 5859873.390328846871853 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_38_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_38", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_718_generated", "manhole_dn": "manhole_721_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386079.86695942771621, 5859885.500408614054322 ], [ 1386081.40363402524963, 5859934.756705570034683 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_38_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_38", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_721_generated", "manhole_dn": "manhole_722_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386081.40363402524963, 5859934.756705570034683 ], [ 1386080.471781946951523, 5859983.948014200665057 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_38_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_38", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 756.5, "invlev_up": 763.79998779296875, "invlev_dn": 754.0, "manhole_up": "manhole_722_generated", "manhole_dn": "manhole_723_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386080.471781946951523, 5859983.948014200665057 ], [ 1386081.101269942475483, 5860033.01989212166518 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_39_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_39", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_718_generated", "manhole_dn": "manhole_724_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386079.86695942771621, 5859885.500408614054322 ], [ 1386051.415038994979113, 5859913.714703594334424 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_39_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_39", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_724_generated", "manhole_dn": "manhole_725_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386051.415038994979113, 5859913.714703594334424 ], [ 1386056.753747603856027, 5859949.43277302198112 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_39_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_39", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_725_generated", "manhole_dn": "manhole_726_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386056.753747603856027, 5859949.43277302198112 ], [ 1386070.153564189793542, 5859990.873222404159606 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_39_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_39", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 756.5, "invlev_up": 763.79998779296875, "invlev_dn": 754.0, "manhole_up": "manhole_726_generated", "manhole_dn": "manhole_723_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386070.153564189793542, 5859990.873222404159606 ], [ 1386081.101269942475483, 5860033.01989212166518 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.5, "elevtn_dn": 756.5, "invlev_up": 754.0, "invlev_dn": 754.0, "manhole_up": "manhole_723_generated", "manhole_dn": "manhole_727_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386081.101269942475483, 5860033.01989212166518 ], [ 1386095.159510504920036, 5860079.476792480796576 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.5, "elevtn_dn": 720.29998779296875, "invlev_up": 754.0, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_727_generated", "manhole_dn": "manhole_728_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386095.159510504920036, 5860079.476792480796576 ], [ 1386119.249574675457552, 5860122.285581497475505 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_728_generated", "manhole_dn": "manhole_729_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386119.249574675457552, 5860122.285581497475505 ], [ 1386143.813145637512207, 5860164.822058788500726 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 732.5, "invlev_up": 717.79998779296875, "invlev_dn": 730.0, "manhole_up": "manhole_729_generated", "manhole_dn": "manhole_730_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386143.813145637512207, 5860164.822058788500726 ], [ 1386168.698389830067754, 5860207.173543182201684 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.5, "elevtn_dn": 732.5, "invlev_up": 730.0, "invlev_dn": 730.0, "manhole_up": "manhole_730_generated", "manhole_dn": "manhole_731_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386168.698389830067754, 5860207.173543182201684 ], [ 1386190.960878706537187, 5860250.914158629253507 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.5, "elevtn_dn": 720.29998779296875, "invlev_up": 730.0, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_731_generated", "manhole_dn": "manhole_732_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386190.960878706537187, 5860250.914158629253507 ], [ 1386212.013376480899751, 5860295.295640649273992 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 729.10003662109375, "invlev_up": 717.79998779296875, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_732_generated", "manhole_dn": "manhole_733_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386212.013376480899751, 5860295.295640649273992 ], [ 1386233.065874255495146, 5860339.677122670225799 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 729.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_733_generated", "manhole_dn": "manhole_734_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386233.065874255495146, 5860339.677122670225799 ], [ 1386254.118372030090541, 5860384.058604690246284 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 729.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_734_generated", "manhole_dn": "manhole_735_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386254.118372030090541, 5860384.058604690246284 ], [ 1386270.265550139825791, 5860430.368606903590262 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 746.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 743.60003662109375, "manhole_up": "manhole_735_generated", "manhole_dn": "manhole_736_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386270.265550139825791, 5860430.368606903590262 ], [ 1386284.690116602927446, 5860477.310510716401041 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 746.10003662109375, "elevtn_dn": 746.10003662109375, "invlev_up": 743.60003662109375, "invlev_dn": 743.60003662109375, "manhole_up": "manhole_736_generated", "manhole_dn": "manhole_737_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386284.690116602927446, 5860477.310510716401041 ], [ 1386295.943752367515117, 5860525.125563691370189 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 746.10003662109375, "elevtn_dn": 720.29998779296875, "invlev_up": 743.60003662109375, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_737_generated", "manhole_dn": "manhole_738_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386295.943752367515117, 5860525.125563691370189 ], [ 1386307.197388132335618, 5860572.940616665408015 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_738_generated", "manhole_dn": "manhole_739_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386307.197388132335618, 5860572.940616665408015 ], [ 1386318.451023896923289, 5860620.755669640377164 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_739_generated", "manhole_dn": "manhole_740_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386318.451023896923289, 5860620.755669640377164 ], [ 1386329.704659661510959, 5860668.57072261441499 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 737.60003662109375, "invlev_up": 717.79998779296875, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_740_generated", "manhole_dn": "manhole_741_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386329.704659661510959, 5860668.57072261441499 ], [ 1386340.95829542633146, 5860716.385775589384139 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 737.60003662109375, "invlev_up": 735.10003662109375, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_741_generated", "manhole_dn": "manhole_742_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386340.95829542633146, 5860716.385775589384139 ], [ 1386352.211931190919131, 5860764.200828563421965 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 737.60003662109375, "invlev_up": 735.10003662109375, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_742_generated", "manhole_dn": "manhole_743_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386352.211931190919131, 5860764.200828563421965 ], [ 1386365.771370212780312, 5860811.365820310078561 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 744.5, "invlev_up": 735.10003662109375, "invlev_dn": 742.0, "manhole_up": "manhole_743_generated", "manhole_dn": "manhole_744_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386365.771370212780312, 5860811.365820310078561 ], [ 1386381.150273493025452, 5860858.017861452884972 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 744.5, "elevtn_dn": 724.29998779296875, "invlev_up": 742.0, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_744_generated", "manhole_dn": "manhole_745_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386381.150273493025452, 5860858.017861452884972 ], [ 1386398.399082327727228, 5860903.951519219204783 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_745_generated", "manhole_dn": "manhole_746_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386398.399082327727228, 5860903.951519219204783 ], [ 1386418.211523674428463, 5860948.90027645137161 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_746_generated", "manhole_dn": "manhole_747_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386418.211523674428463, 5860948.90027645137161 ], [ 1386441.67837643600069, 5860992.033180211670697 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_747_generated", "manhole_dn": "manhole_748_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386441.67837643600069, 5860992.033180211670697 ], [ 1386465.536530936835334, 5861034.971648660488427 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.9000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 722.4000244140625, "manhole_up": "manhole_748_generated", "manhole_dn": "manhole_749_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386465.536530936835334, 5861034.971648660488427 ], [ 1386489.394685437437147, 5861077.910117109306157 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.9000244140625, "elevtn_dn": 724.29998779296875, "invlev_up": 722.4000244140625, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_749_generated", "manhole_dn": "manhole_750_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386489.394685437437147, 5861077.910117109306157 ], [ 1386513.252839938271791, 5861120.848585557192564 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_750_generated", "manhole_dn": "manhole_751_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386513.252839938271791, 5861120.848585557192564 ], [ 1386537.110994438873604, 5861163.787054006010294 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_751_generated", "manhole_dn": "manhole_752_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386537.110994438873604, 5861163.787054006010294 ], [ 1386560.969148939708248, 5861206.725522454828024 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_752_generated", "manhole_dn": "manhole_753_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386560.969148939708248, 5861206.725522454828024 ], [ 1386584.827303440310061, 5861249.663990902714431 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_753_generated", "manhole_dn": "manhole_754_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386584.827303440310061, 5861249.663990902714431 ], [ 1386607.696082097478211, 5861293.105181481689215 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_754_generated", "manhole_dn": "manhole_755_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386607.696082097478211, 5861293.105181481689215 ], [ 1386626.999141034670174, 5861338.164890616200864 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 732.4000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_755_generated", "manhole_dn": "manhole_756_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386626.999141034670174, 5861338.164890616200864 ], [ 1386632.635544582502916, 5861386.242180755361915 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_756_generated", "manhole_dn": "manhole_757_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386632.635544582502916, 5861386.242180755361915 ], [ 1386628.332881111185998, 5861435.174896763637662 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_757_generated", "manhole_dn": "manhole_758_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386628.332881111185998, 5861435.174896763637662 ], [ 1386624.030217639869079, 5861484.107612771913409 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 758.79998779296875, "invlev_up": 729.9000244140625, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_758_generated", "manhole_dn": "manhole_759_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386624.030217639869079, 5861484.107612771913409 ], [ 1386619.72755416855216, 5861533.040328779257834 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_759_generated", "manhole_dn": "manhole_760_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386619.72755416855216, 5861533.040328779257834 ], [ 1386620.396809899713844, 5861581.843449912965298 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_760_generated", "manhole_dn": "manhole_761_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386620.396809899713844, 5861581.843449912965298 ], [ 1386627.242796876933426, 5861630.485572309233248 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 777.9000244140625, "invlev_up": 756.29998779296875, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_761_generated", "manhole_dn": "manhole_762_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386627.242796876933426, 5861630.485572309233248 ], [ 1386633.497009602142498, 5861679.177458625286818 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 777.9000244140625, "invlev_up": 775.4000244140625, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_762_generated", "manhole_dn": "manhole_763_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386633.497009602142498, 5861679.177458625286818 ], [ 1386633.587326586712152, 5861728.232037586160004 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 777.9000244140625, "invlev_up": 775.4000244140625, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_763_generated", "manhole_dn": "manhole_764_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386633.587326586712152, 5861728.232037586160004 ], [ 1386628.569951781770214, 5861777.096641942858696 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 787.0, "invlev_up": 775.4000244140625, "invlev_dn": 784.5, "manhole_up": "manhole_764_generated", "manhole_dn": "manhole_765_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386628.569951781770214, 5861777.096641942858696 ], [ 1386623.552576976828277, 5861825.961246299557388 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.0, "elevtn_dn": 787.0, "invlev_up": 784.5, "invlev_dn": 784.5, "manhole_up": "manhole_765_generated", "manhole_dn": "manhole_766_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386623.552576976828277, 5861825.961246299557388 ], [ 1386622.452884682221338, 5861875.377415779046714 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.0, "elevtn_dn": 768.0, "invlev_up": 784.5, "invlev_dn": 765.5, "manhole_up": "manhole_766_generated", "manhole_dn": "manhole_767_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386622.452884682221338, 5861875.377415779046714 ], [ 1386630.050831846194342, 5861924.208797036670148 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_767_generated", "manhole_dn": "manhole_768_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386630.050831846194342, 5861924.208797036670148 ], [ 1386645.112437101313844, 5861971.295391816645861 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_768_generated", "manhole_dn": "manhole_769_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386645.112437101313844, 5861971.295391816645861 ], [ 1386663.826805545249954, 5862017.116109635680914 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 729.0, "invlev_up": 765.5, "invlev_dn": 726.5, "manhole_up": "manhole_769_generated", "manhole_dn": "manhole_770_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386663.826805545249954, 5862017.116109635680914 ], [ 1386682.541173989186063, 5862062.93682745564729 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 729.0, "invlev_up": 726.5, "invlev_dn": 726.5, "manhole_up": "manhole_770_generated", "manhole_dn": "manhole_771_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386682.541173989186063, 5862062.93682745564729 ], [ 1386700.357504795538262, 5862109.113540357910097 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 729.0, "invlev_up": 726.5, "invlev_dn": 726.5, "manhole_up": "manhole_771_generated", "manhole_dn": "manhole_772_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386700.357504795538262, 5862109.113540357910097 ], [ 1386718.120609947945923, 5862155.311352676711977 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 724.29998779296875, "invlev_up": 726.5, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_772_generated", "manhole_dn": "manhole_773_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386718.120609947945923, 5862155.311352676711977 ], [ 1386735.883715100120753, 5862201.509164996445179 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_773_generated", "manhole_dn": "manhole_774_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386735.883715100120753, 5862201.509164996445179 ], [ 1386757.522535112220794, 5862245.993861058726907 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_774_generated", "manhole_dn": "manhole_775_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386757.522535112220794, 5862245.993861058726907 ], [ 1386779.73098383564502, 5862290.226773838512599 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_775_generated", "manhole_dn": "manhole_776_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386779.73098383564502, 5862290.226773838512599 ], [ 1386802.545179207576439, 5862334.095372994430363 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_776_generated", "manhole_dn": "manhole_777_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386802.545179207576439, 5862334.095372994430363 ], [ 1386831.207993831252679, 5862374.446442689746618 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 737.70001220703125, "invlev_up": 721.79998779296875, "invlev_dn": 735.20001220703125, "manhole_up": "manhole_777_generated", "manhole_dn": "manhole_778_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386831.207993831252679, 5862374.446442689746618 ], [ 1386859.988485741894692, 5862414.708453865721822 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.70001220703125, "elevtn_dn": 737.70001220703125, "invlev_up": 735.20001220703125, "invlev_dn": 735.20001220703125, "manhole_up": "manhole_778_generated", "manhole_dn": "manhole_779_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386859.988485741894692, 5862414.708453865721822 ], [ 1386891.035651177866384, 5862453.255039785988629 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.70001220703125, "elevtn_dn": 743.9000244140625, "invlev_up": 735.20001220703125, "invlev_dn": 741.4000244140625, "manhole_up": "manhole_779_generated", "manhole_dn": "manhole_780_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386891.035651177866384, 5862453.255039785988629 ], [ 1386922.082816614070907, 5862491.801625707186759 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 743.9000244140625, "elevtn_dn": 756.0, "invlev_up": 741.4000244140625, "invlev_dn": 753.5, "manhole_up": "manhole_780_generated", "manhole_dn": "manhole_781_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386922.082816614070907, 5862491.801625707186759 ], [ 1386953.12998205027543, 5862530.348211627453566 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.0, "elevtn_dn": 756.0, "invlev_up": 753.5, "invlev_dn": 753.5, "manhole_up": "manhole_781_generated", "manhole_dn": "manhole_782_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386953.12998205027543, 5862530.348211627453566 ], [ 1386984.177147486479953, 5862568.894797547720373 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.0, "elevtn_dn": 761.4000244140625, "invlev_up": 753.5, "invlev_dn": 758.9000244140625, "manhole_up": "manhole_782_generated", "manhole_dn": "manhole_783_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386984.177147486479953, 5862568.894797547720373 ], [ 1387010.83190148579888, 5862610.297833287157118 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.4000244140625, "elevtn_dn": 761.4000244140625, "invlev_up": 758.9000244140625, "invlev_dn": 758.9000244140625, "manhole_up": "manhole_783_generated", "manhole_dn": "manhole_784_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387010.83190148579888, 5862610.297833287157118 ], [ 1387033.474099110113457, 5862654.310293504968286 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.4000244140625, "elevtn_dn": 770.5, "invlev_up": 758.9000244140625, "invlev_dn": 768.0, "manhole_up": "manhole_784_generated", "manhole_dn": "manhole_785_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387033.474099110113457, 5862654.310293504968286 ], [ 1387056.116296734428033, 5862698.322753723710775 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.5, "elevtn_dn": 765.29998779296875, "invlev_up": 768.0, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_785_generated", "manhole_dn": "manhole_786_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387056.116296734428033, 5862698.322753723710775 ], [ 1387078.75849435874261, 5862742.335213942453265 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 765.29998779296875, "invlev_up": 762.79998779296875, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_786_generated", "manhole_dn": "manhole_787_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387078.75849435874261, 5862742.335213942453265 ], [ 1387101.400691983057186, 5862786.347674161195755 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 765.29998779296875, "invlev_up": 762.79998779296875, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_787_generated", "manhole_dn": "manhole_788_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387101.400691983057186, 5862786.347674161195755 ], [ 1387124.783531384309754, 5862829.966971693560481 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 764.20001220703125, "invlev_up": 762.79998779296875, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_788_generated", "manhole_dn": "manhole_789_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387124.783531384309754, 5862829.966971693560481 ], [ 1387148.551342260092497, 5862873.381910757161677 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 764.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_789_generated", "manhole_dn": "manhole_790_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387148.551342260092497, 5862873.381910757161677 ], [ 1387176.029596295906231, 5862914.516764627769589 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 764.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_790_generated", "manhole_dn": "manhole_791_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387176.029596295906231, 5862914.516764627769589 ], [ 1387204.050833505578339, 5862955.315435893833637 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 769.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 766.70001220703125, "manhole_up": "manhole_791_generated", "manhole_dn": "manhole_792_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387204.050833505578339, 5862955.315435893833637 ], [ 1387233.152246462181211, 5862995.351338926702738 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.20001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 766.70001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_792_generated", "manhole_dn": "manhole_793_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387233.152246462181211, 5862995.351338926702738 ], [ 1387262.253659419016913, 5863035.387241959571838 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 770.20001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_793_generated", "manhole_dn": "manhole_794_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387262.253659419016913, 5863035.387241959571838 ], [ 1387289.177211825968698, 5863076.714860137552023 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 770.20001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_794_generated", "manhole_dn": "manhole_795_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387289.177211825968698, 5863076.714860137552023 ], [ 1387304.666786204557866, 5863123.392671256326139 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 762.0, "invlev_up": 770.20001220703125, "invlev_dn": 759.5, "manhole_up": "manhole_795_generated", "manhole_dn": "manhole_796_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387304.666786204557866, 5863123.392671256326139 ], [ 1387314.520281337434426, 5863171.895173518918455 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 777.10003662109375, "invlev_up": 759.5, "invlev_dn": 774.60003662109375, "manhole_up": "manhole_796_generated", "manhole_dn": "manhole_797_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387314.520281337434426, 5863171.895173518918455 ], [ 1387324.142220750683919, 5863220.446013364940882 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.10003662109375, "elevtn_dn": 780.4000244140625, "invlev_up": 774.60003662109375, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_797_generated", "manhole_dn": "manhole_798_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387324.142220750683919, 5863220.446013364940882 ], [ 1387333.764160163700581, 5863268.996853210031986 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 780.4000244140625, "invlev_up": 777.9000244140625, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_798_generated", "manhole_dn": "manhole_799_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387333.764160163700581, 5863268.996853210031986 ], [ 1387343.386099576717243, 5863317.547693055123091 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 780.4000244140625, "invlev_up": 777.9000244140625, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_799_generated", "manhole_dn": "manhole_800_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387343.386099576717243, 5863317.547693055123091 ], [ 1387353.008038989733905, 5863366.098532900214195 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 762.0, "invlev_up": 777.9000244140625, "invlev_dn": 759.5, "manhole_up": "manhole_800_generated", "manhole_dn": "manhole_801_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387353.008038989733905, 5863366.098532900214195 ], [ 1387364.066297837067395, 5863414.311534740030766 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_801_generated", "manhole_dn": "manhole_802_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387364.066297837067395, 5863414.311534740030766 ], [ 1387381.839409928303212, 5863460.427046488039196 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_802_generated", "manhole_dn": "manhole_803_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387381.839409928303212, 5863460.427046488039196 ], [ 1387403.429578960640356, 5863504.96100580971688 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_803_generated", "manhole_dn": "manhole_804_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387403.429578960640356, 5863504.96100580971688 ], [ 1387425.140452897874638, 5863549.440256260335445 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_804_generated", "manhole_dn": "manhole_805_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387425.140452897874638, 5863549.440256260335445 ], [ 1387446.851326835108921, 5863593.91950671095401 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_805_generated", "manhole_dn": "manhole_806_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387446.851326835108921, 5863593.91950671095401 ], [ 1387467.528695637593046, 5863638.888379830867052 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 774.5, "invlev_up": 759.5, "invlev_dn": 772.0, "manhole_up": "manhole_806_generated", "manhole_dn": "manhole_807_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387467.528695637593046, 5863638.888379830867052 ], [ 1387488.196078018052503, 5863683.861984014511108 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.5, "elevtn_dn": 762.0, "invlev_up": 772.0, "invlev_dn": 759.5, "manhole_up": "manhole_807_generated", "manhole_dn": "manhole_808_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387488.196078018052503, 5863683.861984014511108 ], [ 1387508.863468252588063, 5863728.835584589280188 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_808_generated", "manhole_dn": "manhole_809_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387508.863468252588063, 5863728.835584589280188 ], [ 1387529.53130904212594, 5863773.808978110551834 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_809_generated", "manhole_dn": "manhole_810_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387529.53130904212594, 5863773.808978110551834 ], [ 1387553.168002701364458, 5863817.17347530182451 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_810_generated", "manhole_dn": "manhole_811_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387553.168002701364458, 5863817.17347530182451 ], [ 1387579.562712850514799, 5863859.043333718553185 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 777.0, "invlev_up": 759.5, "invlev_dn": 774.5, "manhole_up": "manhole_811_generated", "manhole_dn": "manhole_812_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387579.562712850514799, 5863859.043333718553185 ], [ 1387605.957422999665141, 5863900.913192136213183 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.0, "elevtn_dn": 762.0, "invlev_up": 774.5, "invlev_dn": 759.5, "manhole_up": "manhole_812_generated", "manhole_dn": "manhole_813_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387605.957422999665141, 5863900.913192136213183 ], [ 1387632.352133149048313, 5863942.783050553873181 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E48", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_813_generated", "manhole_dn": "manhole_814_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387632.352133149048313, 5863942.783050553873181 ], [ 1387658.746843298198655, 5863984.652908970601857 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E49", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_814_generated", "manhole_dn": "manhole_815_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387658.746843298198655, 5863984.652908970601857 ], [ 1387685.893106181640178, 5864026.029537551105022 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E50", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_815_generated", "manhole_dn": "manhole_816_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387685.893106181640178, 5864026.029537551105022 ], [ 1387711.231136992340907, 5864068.42725711222738 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E51", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_816_generated", "manhole_dn": "manhole_817_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387711.231136992340907, 5864068.42725711222738 ], [ 1387731.020947323646396, 5864113.414904261007905 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E52", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_817_generated", "manhole_dn": "manhole_818_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387731.020947323646396, 5864113.414904261007905 ], [ 1387737.361907477490604, 5864162.342261835932732 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E53", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_818_generated", "manhole_dn": "manhole_819_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387737.361907477490604, 5864162.342261835932732 ], [ 1387732.727565656881779, 5864211.475179814733565 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E54", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_819_generated", "manhole_dn": "manhole_820_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387732.727565656881779, 5864211.475179814733565 ], [ 1387717.67884943424724, 5864258.627082298509777 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E55", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_820_generated", "manhole_dn": "manhole_821_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387717.67884943424724, 5864258.627082298509777 ], [ 1387709.67210421175696, 5864307.23127611912787 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E56", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 768.0, "invlev_up": 759.5, "invlev_dn": 765.5, "manhole_up": "manhole_821_generated", "manhole_dn": "manhole_822_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387709.67210421175696, 5864307.23127611912787 ], [ 1387707.11288084089756, 5864356.66017600055784 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E57", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_822_generated", "manhole_dn": "manhole_823_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387707.11288084089756, 5864356.66017600055784 ], [ 1387709.591797993984073, 5864406.012949175201356 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E58", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_823_generated", "manhole_dn": "manhole_824_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387709.591797993984073, 5864406.012949175201356 ], [ 1387713.643261310644448, 5864455.341961052268744 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E59", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 777.20001220703125, "invlev_up": 765.5, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_824_generated", "manhole_dn": "manhole_825_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387713.643261310644448, 5864455.341961052268744 ], [ 1387715.877521668095142, 5864504.642317942343652 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E60", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 774.70001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_825_generated", "manhole_dn": "manhole_826_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387715.877521668095142, 5864504.642317942343652 ], [ 1387708.68023270717822, 5864553.426558391191065 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E61", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 774.70001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_826_generated", "manhole_dn": "manhole_827_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387708.68023270717822, 5864553.426558391191065 ], [ 1387690.790250770282, 5864599.575386263430119 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E62", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 810.60003662109375, "invlev_up": 774.70001220703125, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_827_generated", "manhole_dn": "manhole_828_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387690.790250770282, 5864599.575386263430119 ], [ 1387672.900268833618611, 5864645.724214136600494 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E63", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 810.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_828_generated", "manhole_dn": "manhole_829_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387672.900268833618611, 5864645.724214136600494 ], [ 1387659.931900478899479, 5864692.98388583958149 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E64", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 810.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_829_generated", "manhole_dn": "manhole_830_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387659.931900478899479, 5864692.98388583958149 ], [ 1387659.223570322152227, 5864742.029465307481587 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E65", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_830_generated", "manhole_dn": "manhole_831_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387659.223570322152227, 5864742.029465307481587 ], [ 1387675.926896508783102, 5864788.273513910360634 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E66", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 774.10003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 771.60003662109375, "manhole_up": "manhole_831_generated", "manhole_dn": "manhole_832_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387675.926896508783102, 5864788.273513910360634 ], [ 1387702.296291569946334, 5864830.159320239908993 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E67", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.10003662109375, "elevtn_dn": 774.10003662109375, "invlev_up": 771.60003662109375, "invlev_dn": 771.60003662109375, "manhole_up": "manhole_832_generated", "manhole_dn": "manhole_833_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387702.296291569946334, 5864830.159320239908993 ], [ 1387728.665686630876735, 5864872.045126569457352 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E68", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.10003662109375, "elevtn_dn": 782.5, "invlev_up": 771.60003662109375, "invlev_dn": 780.0, "manhole_up": "manhole_833_generated", "manhole_dn": "manhole_834_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387728.665686630876735, 5864872.045126569457352 ], [ 1387751.608185108983889, 5864915.528788692317903 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E69", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 782.5, "invlev_up": 780.0, "invlev_dn": 780.0, "manhole_up": "manhole_834_generated", "manhole_dn": "manhole_835_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387751.608185108983889, 5864915.528788692317903 ], [ 1387766.741664502769709, 5864962.653554677963257 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E70", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 782.5, "invlev_up": 780.0, "invlev_dn": 780.0, "manhole_up": "manhole_835_generated", "manhole_dn": "manhole_836_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387766.741664502769709, 5864962.653554677963257 ], [ 1387778.99191950308159, 5865010.246724016033113 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E71", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 820.20001220703125, "invlev_up": 780.0, "invlev_dn": 817.70001220703125, "manhole_up": "manhole_836_generated", "manhole_dn": "manhole_837_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387778.99191950308159, 5865010.246724016033113 ], [ 1387779.554608268430457, 5865059.738633952103555 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E72", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.20001220703125, "elevtn_dn": 820.20001220703125, "invlev_up": 817.70001220703125, "invlev_dn": 817.70001220703125, "manhole_up": "manhole_837_generated", "manhole_dn": "manhole_838_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387779.554608268430457, 5865059.738633952103555 ], [ 1387780.117297033779323, 5865109.230543887242675 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E73", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.20001220703125, "elevtn_dn": 834.60003662109375, "invlev_up": 817.70001220703125, "invlev_dn": 832.10003662109375, "manhole_up": "manhole_838_generated", "manhole_dn": "manhole_839_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387780.117297033779323, 5865109.230543887242675 ], [ 1387782.917817069217563, 5865158.566991245374084 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E74", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 834.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 832.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_839_generated", "manhole_dn": "manhole_840_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387782.917817069217563, 5865158.566991245374084 ], [ 1387789.203931836877018, 5865207.661293652839959 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E75", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_840_generated", "manhole_dn": "manhole_841_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387789.203931836877018, 5865207.661293652839959 ], [ 1387795.490046604769304, 5865256.755596060305834 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E76", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_841_generated", "manhole_dn": "manhole_842_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387795.490046604769304, 5865256.755596060305834 ], [ 1387804.549934879876673, 5865305.332479531876743 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E77", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 809.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_842_generated", "manhole_dn": "manhole_843_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387804.549934879876673, 5865305.332479531876743 ], [ 1387816.386747075244784, 5865353.391356389038265 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E78", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 809.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_843_generated", "manhole_dn": "manhole_844_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387816.386747075244784, 5865353.391356389038265 ], [ 1387828.223559270845726, 5865401.450233246199787 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E79", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 802.5, "invlev_up": 809.10003662109375, "invlev_dn": 800.0, "manhole_up": "manhole_844_generated", "manhole_dn": "manhole_845_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387828.223559270845726, 5865401.450233246199787 ], [ 1387842.96627543354407, 5865448.679594250395894 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E80", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 802.5, "invlev_up": 800.0, "invlev_dn": 800.0, "manhole_up": "manhole_845_generated", "manhole_dn": "manhole_846_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387842.96627543354407, 5865448.679594250395894 ], [ 1387858.283513206522912, 5865495.744953005574644 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E81", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 802.5, "invlev_up": 800.0, "invlev_dn": 800.0, "manhole_up": "manhole_846_generated", "manhole_dn": "manhole_847_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387858.283513206522912, 5865495.744953005574644 ], [ 1387872.788357679266483, 5865543.026506381109357 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E82", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 778.20001220703125, "invlev_up": 800.0, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_847_generated", "manhole_dn": "manhole_848_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387872.788357679266483, 5865543.026506381109357 ], [ 1387882.890574953285977, 5865591.479689701460302 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E83", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_848_generated", "manhole_dn": "manhole_849_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387882.890574953285977, 5865591.479689701460302 ], [ 1387892.992792227305472, 5865639.932873022742569 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E84", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_849_generated", "manhole_dn": "manhole_850_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387892.992792227305472, 5865639.932873022742569 ], [ 1387903.095009501324967, 5865688.386056343093514 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E85", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_850_generated", "manhole_dn": "manhole_851_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387903.095009501324967, 5865688.386056343093514 ], [ 1387913.197226775344461, 5865736.839239663444459 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_42_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 830.9000244140625, "invlev_up": 828.4000244140625, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_852_generated", "manhole_dn": "manhole_853_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387767.438602478476241, 5866395.894650792703032 ], [ 1387758.181959156645462, 5866444.388786932453513 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_42_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 830.9000244140625, "invlev_up": 828.4000244140625, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_853_generated", "manhole_dn": "manhole_854_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387758.181959156645462, 5866444.388786932453513 ], [ 1387748.925315835047513, 5866492.882923071272671 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_42_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 816.5, "invlev_up": 828.4000244140625, "invlev_dn": 814.0, "manhole_up": "manhole_854_generated", "manhole_dn": "manhole_855_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387748.925315835047513, 5866492.882923071272671 ], [ 1387739.668672513216734, 5866541.377059211023152 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_42_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.5, "elevtn_dn": 816.5, "invlev_up": 814.0, "invlev_dn": 814.0, "manhole_up": "manhole_855_generated", "manhole_dn": "manhole_856_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387739.668672513216734, 5866541.377059211023152 ], [ 1387730.412029191618785, 5866589.87119534984231 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_42_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.5, "elevtn_dn": 816.10003662109375, "invlev_up": 814.0, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_856_generated", "manhole_dn": "manhole_857_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387730.412029191618785, 5866589.87119534984231 ], [ 1387721.155385869788006, 5866638.365331489592791 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_42_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 816.10003662109375, "invlev_up": 813.60003662109375, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_857_generated", "manhole_dn": "manhole_858_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387721.155385869788006, 5866638.365331489592791 ], [ 1387711.868742506252602, 5866686.853722332976758 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_42_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 816.10003662109375, "invlev_up": 813.60003662109375, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_858_generated", "manhole_dn": "manhole_859_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387711.868742506252602, 5866686.853722332976758 ], [ 1387702.553355348296463, 5866735.336608462966979 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_42_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 802.4000244140625, "invlev_up": 813.60003662109375, "invlev_dn": 799.9000244140625, "manhole_up": "manhole_859_generated", "manhole_dn": "manhole_860_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387702.553355348296463, 5866735.336608462966979 ], [ 1387692.161796326050535, 5866783.420620376244187 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_43_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_43", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_43", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_861_generated", "manhole_dn": "manhole_862_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387809.534624515566975, 5866309.639251782558858 ], [ 1387788.486613497138023, 5866352.766951287165284 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_43_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_43", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_43", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 830.9000244140625, "invlev_up": 803.70001220703125, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_862_generated", "manhole_dn": "manhole_852_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387788.486613497138023, 5866352.766951287165284 ], [ 1387767.438602478476241, 5866395.894650792703032 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_44_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 840.10003662109375, "invlev_up": 828.4000244140625, "invlev_dn": 837.60003662109375, "manhole_up": "manhole_852_generated", "manhole_dn": "manhole_863_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387767.438602478476241, 5866395.894650792703032 ], [ 1387774.73306847945787, 5866351.644692087545991 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_44_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 840.10003662109375, "elevtn_dn": 806.20001220703125, "invlev_up": 837.60003662109375, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_863_generated", "manhole_dn": "manhole_864_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387774.73306847945787, 5866351.644692087545991 ], [ 1387787.219046234386042, 5866308.756401930935681 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_44_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_864_generated", "manhole_dn": "manhole_865_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387787.219046234386042, 5866308.756401930935681 ], [ 1387802.581935805035755, 5866266.622689731419086 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_44_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_865_generated", "manhole_dn": "manhole_866_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387802.581935805035755, 5866266.622689731419086 ], [ 1387818.989883717847988, 5866224.886323318816721 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_44_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_866_generated", "manhole_dn": "manhole_867_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387818.989883717847988, 5866224.886323318816721 ], [ 1387838.767447788733989, 5866184.784887914545834 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_44_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_867_generated", "manhole_dn": "manhole_868_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387838.767447788733989, 5866184.784887914545834 ], [ 1387862.375427621416748, 5866146.679679537191987 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_44_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 803.9000244140625, "invlev_up": 825.20001220703125, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_868_generated", "manhole_dn": "manhole_869_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387862.375427621416748, 5866146.679679537191987 ], [ 1387890.316308293025941, 5866111.904927220195532 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_44_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_869_generated", "manhole_dn": "manhole_870_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387890.316308293025941, 5866111.904927220195532 ], [ 1387932.086585889104754, 5866099.149365295656025 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_45_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_45", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_871_generated", "manhole_dn": "manhole_872_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387931.614702571649104, 5866170.542120457626879 ], [ 1387899.497387683717534, 5866203.806988564319909 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_45_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_45", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 806.20001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_872_generated", "manhole_dn": "manhole_873_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387899.497387683717534, 5866203.806988564319909 ], [ 1387869.509799961000681, 5866239.084409636445343 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_45_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_45", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_873_generated", "manhole_dn": "manhole_874_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387869.509799961000681, 5866239.084409636445343 ], [ 1387839.522212238283828, 5866274.361830709502101 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_45_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_45", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_874_generated", "manhole_dn": "manhole_861_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387839.522212238283828, 5866274.361830709502101 ], [ 1387809.534624515566975, 5866309.639251782558858 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_46_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_870_generated", "manhole_dn": "manhole_875_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387932.086585889104754, 5866099.149365295656025 ], [ 1387908.367353544337675, 5866141.903963415883482 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_46_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_875_generated", "manhole_dn": "manhole_876_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387908.367353544337675, 5866141.903963415883482 ], [ 1387876.955022902460769, 5866179.987773489207029 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_46_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 827.70001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_876_generated", "manhole_dn": "manhole_877_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387876.955022902460769, 5866179.987773489207029 ], [ 1387847.458594153402373, 5866219.470102892257273 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_46_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_877_generated", "manhole_dn": "manhole_878_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387847.458594153402373, 5866219.470102892257273 ], [ 1387823.639855962945148, 5866262.662997540086508 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_46_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_878_generated", "manhole_dn": "manhole_861_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387823.639855962945148, 5866262.662997540086508 ], [ 1387809.534624515566975, 5866309.639251782558858 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_47_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_879_generated", "manhole_dn": "manhole_880_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.443674022099003, 5865845.093254727311432 ], [ 1387943.318034203490242, 5865887.628139751963317 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_47_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_880_generated", "manhole_dn": "manhole_881_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387943.318034203490242, 5865887.628139751963317 ], [ 1387946.009428307646886, 5865930.175072746351361 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_47_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 816.70001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_881_generated", "manhole_dn": "manhole_882_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387946.009428307646886, 5865930.175072746351361 ], [ 1387948.700822412036359, 5865972.722005739808083 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_47_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_882_generated", "manhole_dn": "manhole_883_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387948.700822412036359, 5865972.722005739808083 ], [ 1387944.872250664513558, 5866015.105105520226061 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_47_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_883_generated", "manhole_dn": "manhole_884_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387944.872250664513558, 5866015.105105520226061 ], [ 1387940.047370131826028, 5866057.463170127011836 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_47_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 803.9000244140625, "invlev_up": 814.20001220703125, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_884_generated", "manhole_dn": "manhole_870_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.047370131826028, 5866057.463170127011836 ], [ 1387932.086585889104754, 5866099.149365295656025 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_48_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_48", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_48", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 786.29998779296875, "invlev_up": 801.4000244140625, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_870_generated", "manhole_dn": "manhole_885_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387932.086585889104754, 5866099.149365295656025 ], [ 1387975.279995472636074, 5866107.425722245126963 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E125", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.5, "elevtn_dn": 910.4000244140625, "invlev_up": 907.0, "invlev_dn": 907.9000244140625, "manhole_up": "manhole_886_generated", "manhole_dn": "manhole_887_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392926.966794768813998, 5866808.501405037939548 ], [ 1392879.417931769276038, 5866793.491589142940938 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E126", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 910.4000244140625, "elevtn_dn": 910.4000244140625, "invlev_up": 907.9000244140625, "invlev_dn": 907.9000244140625, "manhole_up": "manhole_887_generated", "manhole_dn": "manhole_888_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392879.417931769276038, 5866793.491589142940938 ], [ 1392831.869068769738078, 5866778.481773247942328 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E127", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 910.4000244140625, "elevtn_dn": 865.0, "invlev_up": 907.9000244140625, "invlev_dn": 862.5, "manhole_up": "manhole_888_generated", "manhole_dn": "manhole_889_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392831.869068769738078, 5866778.481773247942328 ], [ 1392784.320205770200118, 5866763.471957352943718 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E128", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 865.0, "elevtn_dn": 865.0, "invlev_up": 862.5, "invlev_dn": 862.5, "manhole_up": "manhole_889_generated", "manhole_dn": "manhole_890_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392784.320205770200118, 5866763.471957352943718 ], [ 1392736.771342770429328, 5866748.462141457945108 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E129", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 865.0, "elevtn_dn": 878.4000244140625, "invlev_up": 862.5, "invlev_dn": 875.9000244140625, "manhole_up": "manhole_890_generated", "manhole_dn": "manhole_891_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392736.771342770429328, 5866748.462141457945108 ], [ 1392689.222479770891368, 5866733.452325562946498 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E130", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 878.4000244140625, "elevtn_dn": 878.4000244140625, "invlev_up": 875.9000244140625, "invlev_dn": 875.9000244140625, "manhole_up": "manhole_891_generated", "manhole_dn": "manhole_892_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392689.222479770891368, 5866733.452325562946498 ], [ 1392641.673616771353409, 5866718.442509667947888 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E131", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 878.4000244140625, "elevtn_dn": 904.9000244140625, "invlev_up": 875.9000244140625, "invlev_dn": 902.4000244140625, "manhole_up": "manhole_892_generated", "manhole_dn": "manhole_893_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392641.673616771353409, 5866718.442509667947888 ], [ 1392594.124753771815449, 5866703.432693773880601 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E132", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 904.9000244140625, "elevtn_dn": 904.9000244140625, "invlev_up": 902.4000244140625, "invlev_dn": 902.4000244140625, "manhole_up": "manhole_893_generated", "manhole_dn": "manhole_894_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392594.124753771815449, 5866703.432693773880601 ], [ 1392546.575890772277489, 5866688.422877878881991 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E133", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 904.9000244140625, "elevtn_dn": 931.5, "invlev_up": 902.4000244140625, "invlev_dn": 929.0, "manhole_up": "manhole_894_generated", "manhole_dn": "manhole_895_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392546.575890772277489, 5866688.422877878881991 ], [ 1392499.02702777273953, 5866673.413061983883381 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E134", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 931.5, "elevtn_dn": 931.5, "invlev_up": 929.0, "invlev_dn": 929.0, "manhole_up": "manhole_895_generated", "manhole_dn": "manhole_896_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392499.02702777273953, 5866673.413061983883381 ], [ 1392451.47816477320157, 5866658.403246088884771 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E135", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 931.5, "elevtn_dn": 926.29998779296875, "invlev_up": 929.0, "invlev_dn": 923.79998779296875, "manhole_up": "manhole_896_generated", "manhole_dn": "manhole_897_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392451.47816477320157, 5866658.403246088884771 ], [ 1392403.92930177366361, 5866643.393430193886161 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E136", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 926.29998779296875, "elevtn_dn": 849.79998779296875, "invlev_up": 923.79998779296875, "invlev_dn": 847.29998779296875, "manhole_up": "manhole_897_generated", "manhole_dn": "manhole_898_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392403.92930177366361, 5866643.393430193886161 ], [ 1392356.380438774125651, 5866628.383614298887551 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E137", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 849.79998779296875, "elevtn_dn": 875.20001220703125, "invlev_up": 847.29998779296875, "invlev_dn": 872.70001220703125, "manhole_up": "manhole_898_generated", "manhole_dn": "manhole_899_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392356.380438774125651, 5866628.383614298887551 ], [ 1392308.831575774587691, 5866613.373798403888941 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E138", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 875.20001220703125, "elevtn_dn": 875.20001220703125, "invlev_up": 872.70001220703125, "invlev_dn": 872.70001220703125, "manhole_up": "manhole_899_generated", "manhole_dn": "manhole_900_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392308.831575774587691, 5866613.373798403888941 ], [ 1392261.282712775049731, 5866598.363982509821653 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E139", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 875.20001220703125, "elevtn_dn": 928.10003662109375, "invlev_up": 872.70001220703125, "invlev_dn": 925.60003662109375, "manhole_up": "manhole_900_generated", "manhole_dn": "manhole_901_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392261.282712775049731, 5866598.363982509821653 ], [ 1392213.733849775511771, 5866583.354166614823043 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E140", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 928.10003662109375, "elevtn_dn": 928.10003662109375, "invlev_up": 925.60003662109375, "invlev_dn": 925.60003662109375, "manhole_up": "manhole_901_generated", "manhole_dn": "manhole_902_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392213.733849775511771, 5866583.354166614823043 ], [ 1392166.184986775973812, 5866568.344350719824433 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E141", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 928.10003662109375, "elevtn_dn": 936.79998779296875, "invlev_up": 925.60003662109375, "invlev_dn": 934.29998779296875, "manhole_up": "manhole_902_generated", "manhole_dn": "manhole_903_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392166.184986775973812, 5866568.344350719824433 ], [ 1392119.234377897810191, 5866551.59017149079591 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E142", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 936.79998779296875, "elevtn_dn": 936.79998779296875, "invlev_up": 934.29998779296875, "invlev_dn": 934.29998779296875, "manhole_up": "manhole_903_generated", "manhole_dn": "manhole_904_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392119.234377897810191, 5866551.59017149079591 ], [ 1392072.481987217208371, 5866534.25803626794368 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E143", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 936.79998779296875, "elevtn_dn": 929.79998779296875, "invlev_up": 934.29998779296875, "invlev_dn": 927.29998779296875, "manhole_up": "manhole_904_generated", "manhole_dn": "manhole_905_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392072.481987217208371, 5866534.25803626794368 ], [ 1392025.729596536839381, 5866516.925901044160128 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E144", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 929.79998779296875, "elevtn_dn": 892.29998779296875, "invlev_up": 927.29998779296875, "invlev_dn": 889.79998779296875, "manhole_up": "manhole_905_generated", "manhole_dn": "manhole_906_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392025.729596536839381, 5866516.925901044160128 ], [ 1391978.977205856470391, 5866499.593765820376575 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E145", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 892.29998779296875, "elevtn_dn": 911.4000244140625, "invlev_up": 889.79998779296875, "invlev_dn": 908.9000244140625, "manhole_up": "manhole_906_generated", "manhole_dn": "manhole_907_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391978.977205856470391, 5866499.593765820376575 ], [ 1391932.224815175868571, 5866482.261630596593022 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E146", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.4000244140625, "elevtn_dn": 911.4000244140625, "invlev_up": 908.9000244140625, "invlev_dn": 908.9000244140625, "manhole_up": "manhole_907_generated", "manhole_dn": "manhole_908_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391932.224815175868571, 5866482.261630596593022 ], [ 1391885.472424495499581, 5866464.92949537280947 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E147", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.4000244140625, "elevtn_dn": 933.20001220703125, "invlev_up": 908.9000244140625, "invlev_dn": 930.70001220703125, "manhole_up": "manhole_908_generated", "manhole_dn": "manhole_909_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391885.472424495499581, 5866464.92949537280947 ], [ 1391838.720033814897761, 5866447.59736014995724 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E148", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.20001220703125, "elevtn_dn": 933.20001220703125, "invlev_up": 930.70001220703125, "invlev_dn": 930.70001220703125, "manhole_up": "manhole_909_generated", "manhole_dn": "manhole_910_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391838.720033814897761, 5866447.59736014995724 ], [ 1391791.967643134528771, 5866430.265224926173687 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E149", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.20001220703125, "elevtn_dn": 939.4000244140625, "invlev_up": 930.70001220703125, "invlev_dn": 936.9000244140625, "manhole_up": "manhole_910_generated", "manhole_dn": "manhole_911_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391791.967643134528771, 5866430.265224926173687 ], [ 1391745.215252453926951, 5866412.933089702390134 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E150", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 939.4000244140625, "elevtn_dn": 939.4000244140625, "invlev_up": 936.9000244140625, "invlev_dn": 936.9000244140625, "manhole_up": "manhole_911_generated", "manhole_dn": "manhole_912_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391745.215252453926951, 5866412.933089702390134 ], [ 1391698.462861773557961, 5866395.600954478606582 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E151", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 939.4000244140625, "elevtn_dn": 952.70001220703125, "invlev_up": 936.9000244140625, "invlev_dn": 950.20001220703125, "manhole_up": "manhole_912_generated", "manhole_dn": "manhole_913_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391698.462861773557961, 5866395.600954478606582 ], [ 1391651.710471092956141, 5866378.268819254823029 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E152", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.70001220703125, "elevtn_dn": 889.4000244140625, "invlev_up": 950.20001220703125, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_913_generated", "manhole_dn": "manhole_914_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391651.710471092956141, 5866378.268819254823029 ], [ 1391604.958080412587151, 5866360.936684031039476 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E153", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 848.70001220703125, "invlev_up": 886.9000244140625, "invlev_dn": 846.20001220703125, "manhole_up": "manhole_914_generated", "manhole_dn": "manhole_915_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391604.958080412587151, 5866360.936684031039476 ], [ 1391558.205689732218161, 5866343.604548808187246 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E154", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 848.70001220703125, "elevtn_dn": 848.70001220703125, "invlev_up": 846.20001220703125, "invlev_dn": 846.20001220703125, "manhole_up": "manhole_915_generated", "manhole_dn": "manhole_916_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391558.205689732218161, 5866343.604548808187246 ], [ 1391511.453299051616341, 5866326.272413584403694 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E155", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 848.70001220703125, "elevtn_dn": 846.0, "invlev_up": 846.20001220703125, "invlev_dn": 843.5, "manhole_up": "manhole_916_generated", "manhole_dn": "manhole_917_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391511.453299051616341, 5866326.272413584403694 ], [ 1391464.700908371247351, 5866308.940278360620141 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E156", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.0, "elevtn_dn": 846.0, "invlev_up": 843.5, "invlev_dn": 843.5, "manhole_up": "manhole_917_generated", "manhole_dn": "manhole_918_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391464.700908371247351, 5866308.940278360620141 ], [ 1391417.948517690645531, 5866291.608143136836588 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E157", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.0, "elevtn_dn": 849.9000244140625, "invlev_up": 843.5, "invlev_dn": 847.4000244140625, "manhole_up": "manhole_918_generated", "manhole_dn": "manhole_919_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391417.948517690645531, 5866291.608143136836588 ], [ 1391371.196127010276541, 5866274.276007913053036 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E158", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 849.9000244140625, "elevtn_dn": 849.9000244140625, "invlev_up": 847.4000244140625, "invlev_dn": 847.4000244140625, "manhole_up": "manhole_919_generated", "manhole_dn": "manhole_920_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391371.196127010276541, 5866274.276007913053036 ], [ 1391321.986832652939484, 5866269.550851707346737 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E159", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 849.9000244140625, "elevtn_dn": 895.70001220703125, "invlev_up": 847.4000244140625, "invlev_dn": 893.20001220703125, "manhole_up": "manhole_920_generated", "manhole_dn": "manhole_921_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391321.986832652939484, 5866269.550851707346737 ], [ 1391272.147464629728347, 5866268.058758955448866 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E160", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 895.70001220703125, "elevtn_dn": 895.70001220703125, "invlev_up": 893.20001220703125, "invlev_dn": 893.20001220703125, "manhole_up": "manhole_921_generated", "manhole_dn": "manhole_922_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391272.147464629728347, 5866268.058758955448866 ], [ 1391222.30809660628438, 5866266.566666204482317 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E161", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 895.70001220703125, "elevtn_dn": 932.0, "invlev_up": 893.20001220703125, "invlev_dn": 929.5, "manhole_up": "manhole_922_generated", "manhole_dn": "manhole_923_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391222.30809660628438, 5866266.566666204482317 ], [ 1391172.468728582840413, 5866265.074573452584445 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E162", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 932.0, "invlev_up": 929.5, "invlev_dn": 929.5, "manhole_up": "manhole_923_generated", "manhole_dn": "manhole_924_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391172.468728582840413, 5866265.074573452584445 ], [ 1391122.629360559629276, 5866263.582480700686574 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E163", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 915.20001220703125, "invlev_up": 929.5, "invlev_dn": 912.70001220703125, "manhole_up": "manhole_924_generated", "manhole_dn": "manhole_925_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391122.629360559629276, 5866263.582480700686574 ], [ 1391072.789992536185309, 5866262.090387949720025 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E164", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.20001220703125, "elevtn_dn": 880.70001220703125, "invlev_up": 912.70001220703125, "invlev_dn": 878.20001220703125, "manhole_up": "manhole_925_generated", "manhole_dn": "manhole_926_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391072.789992536185309, 5866262.090387949720025 ], [ 1391022.950624512741342, 5866260.598295197822154 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E165", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 880.70001220703125, "elevtn_dn": 880.70001220703125, "invlev_up": 878.20001220703125, "invlev_dn": 878.20001220703125, "manhole_up": "manhole_926_generated", "manhole_dn": "manhole_927_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391022.950624512741342, 5866260.598295197822154 ], [ 1390973.111256489530206, 5866259.106202445924282 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E166", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 880.70001220703125, "elevtn_dn": 889.4000244140625, "invlev_up": 878.20001220703125, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_927_generated", "manhole_dn": "manhole_928_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390973.111256489530206, 5866259.106202445924282 ], [ 1390923.271888466086239, 5866257.614109694957733 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E167", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 889.4000244140625, "invlev_up": 886.9000244140625, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_928_generated", "manhole_dn": "manhole_929_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390923.271888466086239, 5866257.614109694957733 ], [ 1390873.432520442642272, 5866256.122016943059862 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E168", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 935.79998779296875, "invlev_up": 886.9000244140625, "invlev_dn": 933.29998779296875, "manhole_up": "manhole_929_generated", "manhole_dn": "manhole_930_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390873.432520442642272, 5866256.122016943059862 ], [ 1390823.593152419198304, 5866254.62992419116199 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E169", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.79998779296875, "elevtn_dn": 935.79998779296875, "invlev_up": 933.29998779296875, "invlev_dn": 933.29998779296875, "manhole_up": "manhole_930_generated", "manhole_dn": "manhole_931_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390823.593152419198304, 5866254.62992419116199 ], [ 1390773.753784395987168, 5866253.137831440195441 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E170", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.79998779296875, "elevtn_dn": 957.79998779296875, "invlev_up": 933.29998779296875, "invlev_dn": 955.29998779296875, "manhole_up": "manhole_931_generated", "manhole_dn": "manhole_932_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390773.753784395987168, 5866253.137831440195441 ], [ 1390723.914416372543201, 5866251.64573868829757 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E171", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.79998779296875, "elevtn_dn": 957.79998779296875, "invlev_up": 955.29998779296875, "invlev_dn": 955.29998779296875, "manhole_up": "manhole_932_generated", "manhole_dn": "manhole_933_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390723.914416372543201, 5866251.64573868829757 ], [ 1390674.075048349099234, 5866250.153645936399698 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E172", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.79998779296875, "elevtn_dn": 957.0, "invlev_up": 955.29998779296875, "invlev_dn": 954.5, "manhole_up": "manhole_933_generated", "manhole_dn": "manhole_934_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390674.075048349099234, 5866250.153645936399698 ], [ 1390624.235680325888097, 5866248.661553185433149 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E173", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.0, "elevtn_dn": 957.0, "invlev_up": 954.5, "invlev_dn": 954.5, "manhole_up": "manhole_934_generated", "manhole_dn": "manhole_935_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390624.235680325888097, 5866248.661553185433149 ], [ 1390574.39631230244413, 5866247.169460433535278 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E174", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.0, "elevtn_dn": 964.5, "invlev_up": 954.5, "invlev_dn": 962.0, "manhole_up": "manhole_935_generated", "manhole_dn": "manhole_936_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390574.39631230244413, 5866247.169460433535278 ], [ 1390524.556944279000163, 5866245.677367681637406 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E175", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 964.5, "invlev_up": 962.0, "invlev_dn": 962.0, "manhole_up": "manhole_936_generated", "manhole_dn": "manhole_937_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390524.556944279000163, 5866245.677367681637406 ], [ 1390474.717576255789027, 5866244.185274930670857 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E176", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 948.5, "invlev_up": 962.0, "invlev_dn": 946.0, "manhole_up": "manhole_937_generated", "manhole_dn": "manhole_938_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390474.717576255789027, 5866244.185274930670857 ], [ 1390424.87820823234506, 5866242.693182178772986 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E177", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 948.5, "elevtn_dn": 970.10003662109375, "invlev_up": 946.0, "invlev_dn": 967.60003662109375, "manhole_up": "manhole_938_generated", "manhole_dn": "manhole_939_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390424.87820823234506, 5866242.693182178772986 ], [ 1390375.038840208901092, 5866241.201089426875114 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E178", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 970.10003662109375, "elevtn_dn": 970.10003662109375, "invlev_up": 967.60003662109375, "invlev_dn": 967.60003662109375, "manhole_up": "manhole_939_generated", "manhole_dn": "manhole_940_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390375.038840208901092, 5866241.201089426875114 ], [ 1390325.199472185689956, 5866239.708996675908566 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E179", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 970.10003662109375, "elevtn_dn": 975.4000244140625, "invlev_up": 967.60003662109375, "invlev_dn": 972.9000244140625, "manhole_up": "manhole_940_generated", "manhole_dn": "manhole_941_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390325.199472185689956, 5866239.708996675908566 ], [ 1390275.360104162245989, 5866238.216903924010694 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E180", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 975.4000244140625, "elevtn_dn": 975.4000244140625, "invlev_up": 972.9000244140625, "invlev_dn": 972.9000244140625, "manhole_up": "manhole_941_generated", "manhole_dn": "manhole_942_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390275.360104162245989, 5866238.216903924010694 ], [ 1390225.520736138802022, 5866236.724811173044145 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E181", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 975.4000244140625, "elevtn_dn": 1034.5, "invlev_up": 972.9000244140625, "invlev_dn": 1032.0, "manhole_up": "manhole_942_generated", "manhole_dn": "manhole_943_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390225.520736138802022, 5866236.724811173044145 ], [ 1390175.681368115358055, 5866235.232718421146274 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E182", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1034.5, "elevtn_dn": 1034.5, "invlev_up": 1032.0, "invlev_dn": 1032.0, "manhole_up": "manhole_943_generated", "manhole_dn": "manhole_944_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390175.681368115358055, 5866235.232718421146274 ], [ 1390125.842000092146918, 5866233.740625669248402 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E183", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1034.5, "elevtn_dn": 1053.9000244140625, "invlev_up": 1032.0, "invlev_dn": 1051.4000244140625, "manhole_up": "manhole_944_generated", "manhole_dn": "manhole_945_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390125.842000092146918, 5866233.740625669248402 ], [ 1390076.002632068702951, 5866232.248532918281853 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E184", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.9000244140625, "elevtn_dn": 956.9000244140625, "invlev_up": 1051.4000244140625, "invlev_dn": 954.4000244140625, "manhole_up": "manhole_945_generated", "manhole_dn": "manhole_946_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390076.002632068702951, 5866232.248532918281853 ], [ 1390026.163264045258984, 5866230.756440166383982 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E185", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 956.9000244140625, "elevtn_dn": 988.79998779296875, "invlev_up": 954.4000244140625, "invlev_dn": 986.29998779296875, "manhole_up": "manhole_946_generated", "manhole_dn": "manhole_947_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390026.163264045258984, 5866230.756440166383982 ], [ 1389976.323896022047848, 5866229.26434741448611 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E186", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 988.79998779296875, "elevtn_dn": 988.79998779296875, "invlev_up": 986.29998779296875, "invlev_dn": 986.29998779296875, "manhole_up": "manhole_947_generated", "manhole_dn": "manhole_948_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389976.323896022047848, 5866229.26434741448611 ], [ 1389926.48452799860388, 5866227.772254663519561 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E187", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 988.79998779296875, "elevtn_dn": 1051.0999755859375, "invlev_up": 986.29998779296875, "invlev_dn": 1048.5999755859375, "manhole_up": "manhole_948_generated", "manhole_dn": "manhole_949_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389926.48452799860388, 5866227.772254663519561 ], [ 1389876.645159975159913, 5866226.28016191162169 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E188", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1051.0999755859375, "elevtn_dn": 1051.0999755859375, "invlev_up": 1048.5999755859375, "invlev_dn": 1048.5999755859375, "manhole_up": "manhole_949_generated", "manhole_dn": "manhole_950_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389876.645159975159913, 5866226.28016191162169 ], [ 1389826.805791951948777, 5866224.788069159723818 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E189", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1051.0999755859375, "elevtn_dn": 1066.9000244140625, "invlev_up": 1048.5999755859375, "invlev_dn": 1064.4000244140625, "manhole_up": "manhole_950_generated", "manhole_dn": "manhole_951_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389826.805791951948777, 5866224.788069159723818 ], [ 1389776.96642392850481, 5866223.295976408757269 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E190", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1066.9000244140625, "elevtn_dn": 1031.2000732421875, "invlev_up": 1064.4000244140625, "invlev_dn": 1028.7000732421875, "manhole_up": "manhole_951_generated", "manhole_dn": "manhole_952_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389776.96642392850481, 5866223.295976408757269 ], [ 1389727.141182830790058, 5866221.468200048431754 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E191", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1031.2000732421875, "elevtn_dn": 1031.2000732421875, "invlev_up": 1028.7000732421875, "invlev_dn": 1028.7000732421875, "manhole_up": "manhole_952_generated", "manhole_dn": "manhole_953_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389727.141182830790058, 5866221.468200048431754 ], [ 1389677.352675863076001, 5866218.767548334784806 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E192", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1031.2000732421875, "elevtn_dn": 986.60003662109375, "invlev_up": 1028.7000732421875, "invlev_dn": 984.10003662109375, "manhole_up": "manhole_953_generated", "manhole_dn": "manhole_954_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389677.352675863076001, 5866218.767548334784806 ], [ 1389627.564168895594776, 5866216.066896621137857 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E193", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 986.60003662109375, "elevtn_dn": 986.60003662109375, "invlev_up": 984.10003662109375, "invlev_dn": 984.10003662109375, "manhole_up": "manhole_954_generated", "manhole_dn": "manhole_955_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389627.564168895594776, 5866216.066896621137857 ], [ 1389577.775661927880719, 5866213.366244907490909 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E194", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 986.60003662109375, "elevtn_dn": 964.70001220703125, "invlev_up": 984.10003662109375, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_955_generated", "manhole_dn": "manhole_956_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389577.775661927880719, 5866213.366244907490909 ], [ 1389527.987154960166663, 5866210.665593194775283 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E195", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 964.70001220703125, "invlev_up": 962.20001220703125, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_956_generated", "manhole_dn": "manhole_957_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389527.987154960166663, 5866210.665593194775283 ], [ 1389478.198647992452607, 5866207.964941481128335 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E196", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 996.29998779296875, "invlev_up": 962.20001220703125, "invlev_dn": 993.79998779296875, "manhole_up": "manhole_957_generated", "manhole_dn": "manhole_958_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389478.198647992452607, 5866207.964941481128335 ], [ 1389428.41014102473855, 5866205.264289767481387 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E197", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 996.29998779296875, "elevtn_dn": 996.29998779296875, "invlev_up": 993.79998779296875, "invlev_dn": 993.79998779296875, "manhole_up": "manhole_958_generated", "manhole_dn": "manhole_959_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389428.41014102473855, 5866205.264289767481387 ], [ 1389378.621634057024494, 5866202.563638053834438 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E198", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 996.29998779296875, "elevtn_dn": 1030.4000244140625, "invlev_up": 993.79998779296875, "invlev_dn": 1027.9000244140625, "manhole_up": "manhole_959_generated", "manhole_dn": "manhole_960_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389378.621634057024494, 5866202.563638053834438 ], [ 1389328.833127089310437, 5866199.86298634018749 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E199", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1030.4000244140625, "elevtn_dn": 1030.4000244140625, "invlev_up": 1027.9000244140625, "invlev_dn": 1027.9000244140625, "manhole_up": "manhole_960_generated", "manhole_dn": "manhole_961_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389328.833127089310437, 5866199.86298634018749 ], [ 1389279.044620121829212, 5866197.162334626540542 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E200", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1030.4000244140625, "elevtn_dn": 1053.800048828125, "invlev_up": 1027.9000244140625, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_961_generated", "manhole_dn": "manhole_962_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389279.044620121829212, 5866197.162334626540542 ], [ 1389229.256113154115155, 5866194.461682912893593 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E201", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1053.800048828125, "invlev_up": 1051.300048828125, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_962_generated", "manhole_dn": "manhole_963_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389229.256113154115155, 5866194.461682912893593 ], [ 1389179.467606186401099, 5866191.761031199246645 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E202", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1067.5999755859375, "invlev_up": 1051.300048828125, "invlev_dn": 1065.0999755859375, "manhole_up": "manhole_963_generated", "manhole_dn": "manhole_964_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389179.467606186401099, 5866191.761031199246645 ], [ 1389129.679099218687043, 5866189.060379485599697 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E203", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1067.5999755859375, "elevtn_dn": 1070.7000732421875, "invlev_up": 1065.0999755859375, "invlev_dn": 1068.2000732421875, "manhole_up": "manhole_964_generated", "manhole_dn": "manhole_965_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389129.679099218687043, 5866189.060379485599697 ], [ 1389079.890592250972986, 5866186.359727771952748 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E204", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1070.7000732421875, "elevtn_dn": 1070.7000732421875, "invlev_up": 1068.2000732421875, "invlev_dn": 1068.2000732421875, "manhole_up": "manhole_965_generated", "manhole_dn": "manhole_966_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389079.890592250972986, 5866186.359727771952748 ], [ 1389030.10208528325893, 5866183.6590760583058 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E205", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1070.7000732421875, "elevtn_dn": 1075.0, "invlev_up": 1068.2000732421875, "invlev_dn": 1072.5, "manhole_up": "manhole_966_generated", "manhole_dn": "manhole_967_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389030.10208528325893, 5866183.6590760583058 ], [ 1388980.313578315777704, 5866180.958424345590174 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E206", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1075.0, "elevtn_dn": 1075.0, "invlev_up": 1072.5, "invlev_dn": 1072.5, "manhole_up": "manhole_967_generated", "manhole_dn": "manhole_968_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388980.313578315777704, 5866180.958424345590174 ], [ 1388930.525071348063648, 5866178.257772631943226 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E207", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1075.0, "elevtn_dn": 1074.0999755859375, "invlev_up": 1072.5, "invlev_dn": 1071.5999755859375, "manhole_up": "manhole_968_generated", "manhole_dn": "manhole_969_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388930.525071348063648, 5866178.257772631943226 ], [ 1388880.736564380349591, 5866175.557120918296278 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E208", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1074.0999755859375, "elevtn_dn": 1074.0999755859375, "invlev_up": 1071.5999755859375, "invlev_dn": 1071.5999755859375, "manhole_up": "manhole_969_generated", "manhole_dn": "manhole_970_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388880.736564380349591, 5866175.557120918296278 ], [ 1388830.948057412635535, 5866172.856469204649329 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E209", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1074.0999755859375, "elevtn_dn": 1053.800048828125, "invlev_up": 1071.5999755859375, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_970_generated", "manhole_dn": "manhole_971_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388830.948057412635535, 5866172.856469204649329 ], [ 1388781.159550444921479, 5866170.155817491002381 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E210", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1053.800048828125, "invlev_up": 1051.300048828125, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_971_generated", "manhole_dn": "manhole_972_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388781.159550444921479, 5866170.155817491002381 ], [ 1388731.371043477207422, 5866167.455165777355433 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E211", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1017.0, "invlev_up": 1051.300048828125, "invlev_dn": 1014.5, "manhole_up": "manhole_972_generated", "manhole_dn": "manhole_973_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388731.371043477207422, 5866167.455165777355433 ], [ 1388681.582536509493366, 5866164.754514063708484 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E212", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1017.0, "elevtn_dn": 1017.0, "invlev_up": 1014.5, "invlev_dn": 1014.5, "manhole_up": "manhole_973_generated", "manhole_dn": "manhole_974_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388681.582536509493366, 5866164.754514063708484 ], [ 1388631.79402954201214, 5866162.053862350061536 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E213", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1017.0, "elevtn_dn": 973.20001220703125, "invlev_up": 1014.5, "invlev_dn": 970.70001220703125, "manhole_up": "manhole_974_generated", "manhole_dn": "manhole_975_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388631.79402954201214, 5866162.053862350061536 ], [ 1388582.005522574298084, 5866159.353210636414587 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E214", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 973.20001220703125, "elevtn_dn": 973.20001220703125, "invlev_up": 970.70001220703125, "invlev_dn": 970.70001220703125, "manhole_up": "manhole_975_generated", "manhole_dn": "manhole_976_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388582.005522574298084, 5866159.353210636414587 ], [ 1388532.217015606584027, 5866156.652558922767639 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E215", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 973.20001220703125, "elevtn_dn": 935.20001220703125, "invlev_up": 970.70001220703125, "invlev_dn": 932.70001220703125, "manhole_up": "manhole_976_generated", "manhole_dn": "manhole_977_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388532.217015606584027, 5866156.652558922767639 ], [ 1388482.428508638869971, 5866153.951907209120691 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E216", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.20001220703125, "elevtn_dn": 935.20001220703125, "invlev_up": 932.70001220703125, "invlev_dn": 932.70001220703125, "manhole_up": "manhole_977_generated", "manhole_dn": "manhole_978_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388482.428508638869971, 5866153.951907209120691 ], [ 1388432.640001671155915, 5866151.251255496405065 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E217", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.20001220703125, "elevtn_dn": 895.79998779296875, "invlev_up": 932.70001220703125, "invlev_dn": 893.29998779296875, "manhole_up": "manhole_978_generated", "manhole_dn": "manhole_979_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388432.640001671155915, 5866151.251255496405065 ], [ 1388382.851494703441858, 5866148.550603782758117 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E218", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 895.79998779296875, "elevtn_dn": 852.60003662109375, "invlev_up": 893.29998779296875, "invlev_dn": 850.10003662109375, "manhole_up": "manhole_979_generated", "manhole_dn": "manhole_980_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388382.851494703441858, 5866148.550603782758117 ], [ 1388333.062987735960633, 5866145.849952069111168 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E219", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 852.60003662109375, "elevtn_dn": 852.60003662109375, "invlev_up": 850.10003662109375, "invlev_dn": 850.10003662109375, "manhole_up": "manhole_980_generated", "manhole_dn": "manhole_981_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388333.062987735960633, 5866145.849952069111168 ], [ 1388283.274480768246576, 5866143.14930035546422 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E220", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 852.60003662109375, "elevtn_dn": 818.4000244140625, "invlev_up": 850.10003662109375, "invlev_dn": 815.9000244140625, "manhole_up": "manhole_981_generated", "manhole_dn": "manhole_982_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388283.274480768246576, 5866143.14930035546422 ], [ 1388233.48597380053252, 5866140.448648641817272 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E221", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.4000244140625, "elevtn_dn": 818.4000244140625, "invlev_up": 815.9000244140625, "invlev_dn": 815.9000244140625, "manhole_up": "manhole_982_generated", "manhole_dn": "manhole_983_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388233.48597380053252, 5866140.448648641817272 ], [ 1388183.697466832818463, 5866137.747996928170323 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_50_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 792.20001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_851_generated", "manhole_dn": "manhole_984_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387913.197226775344461, 5865736.839239663444459 ], [ 1387925.20445894007571, 5865784.545682998374104 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_50_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 804.4000244140625, "invlev_up": 792.20001220703125, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_984_generated", "manhole_dn": "manhole_985_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387925.20445894007571, 5865784.545682998374104 ], [ 1387937.21169110503979, 5865832.252126332372427 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_50_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_985_generated", "manhole_dn": "manhole_986_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387937.21169110503979, 5865832.252126332372427 ], [ 1387954.8270876808092, 5865878.043407939374447 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_50_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_986_generated", "manhole_dn": "manhole_987_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387954.8270876808092, 5865878.043407939374447 ], [ 1387967.620662312954664, 5865925.436966767534614 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_50_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 778.20001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_987_generated", "manhole_dn": "manhole_988_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387967.620662312954664, 5865925.436966767534614 ], [ 1387969.561903131194413, 5865974.386314341798425 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_50_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_988_generated", "manhole_dn": "manhole_989_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.561903131194413, 5865974.386314341798425 ], [ 1387968.98255812516436, 5866023.571071763522923 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_50_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_989_generated", "manhole_dn": "manhole_990_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387968.98255812516436, 5866023.571071763522923 ], [ 1387969.225197304505855, 5866072.657253311946988 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_50_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 786.29998779296875, "invlev_up": 775.70001220703125, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_990_generated", "manhole_dn": "manhole_991_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.225197304505855, 5866072.657253311946988 ], [ 1387988.247399942483753, 5866112.298415473662317 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_50_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 786.29998779296875, "invlev_up": 783.79998779296875, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_991_generated", "manhole_dn": "manhole_992_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387988.247399942483753, 5866112.298415473662317 ], [ 1388034.037428337847814, 5866130.255607943050563 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_51_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 786.29998779296875, "invlev_up": 783.79998779296875, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_992_generated", "manhole_dn": "manhole_993_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388034.037428337847814, 5866130.255607943050563 ], [ 1387988.210684564430267, 5866144.678138472139835 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_51_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 803.9000244140625, "invlev_up": 783.79998779296875, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_993_generated", "manhole_dn": "manhole_994_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387988.210684564430267, 5866144.678138472139835 ], [ 1387944.406121137319133, 5866164.065103021450341 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_51_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_994_generated", "manhole_dn": "manhole_995_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387944.406121137319133, 5866164.065103021450341 ], [ 1387898.376188111724332, 5866173.560075835324824 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_51_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 827.70001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_995_generated", "manhole_dn": "manhole_996_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387898.376188111724332, 5866173.560075835324824 ], [ 1387861.922560503939167, 5866145.113870099186897 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_51_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_996_generated", "manhole_dn": "manhole_997_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387861.922560503939167, 5866145.113870099186897 ], [ 1387862.597008766839281, 5866099.287653629668057 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_51_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_997_generated", "manhole_dn": "manhole_998_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387862.597008766839281, 5866099.287653629668057 ], [ 1387894.296242429409176, 5866064.31225199252367 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_51_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_998_generated", "manhole_dn": "manhole_999_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387894.296242429409176, 5866064.31225199252367 ], [ 1387918.333023339277133, 5866023.860149594023824 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_51_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_999_generated", "manhole_dn": "manhole_1000_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387918.333023339277133, 5866023.860149594023824 ], [ 1387925.576027213362977, 5865976.462517648003995 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_51_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 804.4000244140625, "invlev_up": 814.20001220703125, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1000_generated", "manhole_dn": "manhole_1001_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387925.576027213362977, 5865976.462517648003995 ], [ 1387926.166851800866425, 5865928.505292822606862 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_51_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1001_generated", "manhole_dn": "manhole_1002_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387926.166851800866425, 5865928.505292822606862 ], [ 1387922.175474973395467, 5865880.628693707287312 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_51_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1002_generated", "manhole_dn": "manhole_1003_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387922.175474973395467, 5865880.628693707287312 ], [ 1387918.184098146157339, 5865832.752094592899084 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_51_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 794.70001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_1003_generated", "manhole_dn": "manhole_1004_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387918.184098146157339, 5865832.752094592899084 ], [ 1387914.316889721900225, 5865784.868878290057182 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_51_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 792.20001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_1004_generated", "manhole_dn": "manhole_851_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387914.316889721900225, 5865784.868878290057182 ], [ 1387913.197226775344461, 5865736.839239663444459 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_52_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_52", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.4000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 815.9000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_983_generated", "manhole_dn": "manhole_1005_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388183.697466832818463, 5866137.747996928170323 ], [ 1388133.810787334572524, 5866135.250533932819963 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_52_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_52", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_1005_generated", "manhole_dn": "manhole_1006_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388133.810787334572524, 5866135.250533932819963 ], [ 1388083.924107836093754, 5866132.753070938400924 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_52_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_52", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 786.29998779296875, "invlev_up": 801.4000244140625, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_1006_generated", "manhole_dn": "manhole_992_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388083.924107836093754, 5866132.753070938400924 ], [ 1388034.037428337847814, 5866130.255607943050563 ] ] } }, -{ "type": "Feature", "properties": { "height": 22.5, "width": 60.500781333333329, "bedlev": 865.60003662109375, "branchid": "river_1", "branchtype": "river", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_1", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1394694.070276216836646, 5867648.108302162960172 ], [ 1394694.070276216836646, 5867513.239712204784155 ], [ 1394601.304033889202401, 5867378.373192292638123 ], [ 1394508.537791561568156, 5867243.508742331527174 ], [ 1394415.771549233933911, 5867243.508742331527174 ], [ 1394323.005306906066835, 5867108.646362232975662 ], [ 1394230.23906457843259, 5867108.646362232975662 ], [ 1394137.472822251031175, 5867108.646362232975662 ], [ 1394044.70657992339693, 5866973.78605190385133 ], [ 1393951.940337595762685, 5866973.78605190385133 ], [ 1393859.17409526812844, 5866973.78605190385133 ], [ 1393766.407852940494195, 5866838.927811251021922 ], [ 1393673.641610612627119, 5866838.927811251021922 ], [ 1393580.875368284992874, 5866838.927811251021922 ], [ 1393488.109125957358629, 5866838.927811251021922 ], [ 1393395.342883629724383, 5866838.927811251021922 ], [ 1393302.576641302322969, 5866838.927811251021922 ], [ 1393209.810398974688724, 5866838.927811251021922 ], [ 1393117.044156646821648, 5866704.071640183217824 ], [ 1393024.277914319187403, 5866704.071640183217824 ], [ 1392931.511671991553158, 5866704.071640183217824 ], [ 1392838.745429663918912, 5866704.071640183217824 ], [ 1392745.979187336284667, 5866569.217538607306778 ], [ 1392653.212945008650422, 5866569.217538607306778 ], [ 1392560.446702681016177, 5866569.217538607306778 ], [ 1392467.680460353381932, 5866569.217538607306778 ], [ 1392374.914218025747687, 5866569.217538607306778 ], [ 1392282.147975698113441, 5866434.365506432950497 ], [ 1392189.381733370479196, 5866299.515543567948043 ], [ 1392096.615491042844951, 5866299.515543567948043 ], [ 1392003.849248715210706, 5866299.515543567948043 ], [ 1391911.083006387576461, 5866299.515543567948043 ], [ 1391818.316764059709385, 5866164.667649918235838 ], [ 1391725.55052173207514, 5866164.667649918235838 ], [ 1391632.784279404673725, 5866164.667649918235838 ], [ 1391540.01803707703948, 5866164.667649918235838 ], [ 1391447.251794749405235, 5866164.667649918235838 ], [ 1391354.48555242177099, 5866164.667649918235838 ], [ 1391261.719310093903914, 5866164.667649918235838 ], [ 1391168.953067766269669, 5866164.667649918235838 ], [ 1391076.186825438635424, 5866164.667649918235838 ], [ 1390983.420583111001179, 5866164.667649918235838 ], [ 1390890.654340783366933, 5866164.667649918235838 ], [ 1390797.888098455965519, 5866029.821825394406915 ], [ 1390705.121856128098443, 5866029.821825394406915 ], [ 1390612.355613800464198, 5866029.821825394406915 ], [ 1390519.589371472829953, 5866029.821825394406915 ], [ 1390426.823129145195708, 5866029.821825394406915 ], [ 1390334.056886817561463, 5866029.821825394406915 ], [ 1390241.290644489927217, 5866029.821825394406915 ], [ 1390148.524402162292972, 5865894.978069902397692 ], [ 1390055.758159834658727, 5865894.978069902397692 ], [ 1389962.991917507024482, 5865760.136383352801204 ], [ 1389870.225675179390237, 5865760.136383352801204 ], [ 1389777.459432851755992, 5865760.136383352801204 ], [ 1389684.693190524121746, 5865760.136383352801204 ], [ 1389591.926948196487501, 5865760.136383352801204 ], [ 1389499.160705868853256, 5865625.296765649691224 ], [ 1389406.39446354098618, 5865625.296765649691224 ], [ 1389406.39446354098618, 5865490.459216705523431 ], [ 1389313.628221213351935, 5865355.623736422508955 ], [ 1389313.628221213351935, 5865220.790324714966118 ], [ 1389313.628221213351935, 5865085.958981488831341 ], [ 1389220.86197888571769, 5864951.129706650041044 ], [ 1389128.095736558316275, 5864816.302500107325613 ], [ 1389128.095736558316275, 5864681.477361769415438 ], [ 1389035.32949423068203, 5864546.654291545972228 ], [ 1389128.095736558316275, 5864411.833289342001081 ], [ 1389128.095736558316275, 5864277.014355068095028 ], [ 1389035.32949423068203, 5864142.197488628327847 ], [ 1388942.563251903047785, 5864007.382689936086535 ], [ 1388849.797009575180709, 5863872.569958896376193 ], [ 1388757.030767247546464, 5863872.569958896376193 ], [ 1388664.264524919912219, 5863737.759295416995883 ], [ 1388571.498282592277974, 5863602.950699406675994 ], [ 1388571.498282592277974, 5863468.144170773215592 ], [ 1388571.498282592277974, 5863333.339709427207708 ], [ 1388478.732040264643729, 5863333.339709427207708 ], [ 1388385.965797937009484, 5863198.537315272726119 ], [ 1388293.199555609375238, 5863198.537315272726119 ], [ 1388200.433313281740993, 5863198.537315272726119 ], [ 1388107.667070954106748, 5863063.736988220363855 ], [ 1388014.900828626472503, 5863063.736988220363855 ], [ 1387922.134586298838258, 5863063.736988220363855 ], [ 1387829.368343971204013, 5862928.938728176057339 ], [ 1387736.602101643569767, 5862794.142535050399601 ], [ 1387736.602101643569767, 5862659.348408752121031 ], [ 1387736.602101643569767, 5862524.556349185295403 ], [ 1387643.835859315935522, 5862389.766356259584427 ], [ 1387551.069616988068447, 5862254.978429886512458 ], [ 1387458.303374660667032, 5862254.978429886512458 ], [ 1387365.537132333032787, 5862254.978429886512458 ], [ 1387272.770890005398542, 5862254.978429886512458 ], [ 1387180.004647677764297, 5862254.978429886512458 ], [ 1387087.238405350130051, 5862254.978429886512458 ], [ 1386994.472163022495806, 5862120.192569970153272 ] ] } }, -{ "type": "Feature", "properties": { "height": 13.574996948242188, "width": 63.595319, "bedlev": 813.29998779296875, "branchid": "river_2", "branchtype": "river", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_2", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386066.809739745920524, 5868052.726493230089545 ], [ 1386159.575982073554769, 5868052.726493230089545 ], [ 1386252.342224401189014, 5867917.851692584343255 ], [ 1386345.108466728823259, 5867917.851692584343255 ], [ 1386437.874709056690335, 5867917.851692584343255 ], [ 1386530.64095138432458, 5867917.851692584343255 ], [ 1386623.407193711958826, 5867917.851692584343255 ], [ 1386716.17343603936024, 5867782.978962258435786 ], [ 1386808.939678366994485, 5867782.978962258435786 ], [ 1386901.70592069462873, 5867782.978962258435786 ], [ 1386994.472163022495806, 5867648.108302162960172 ], [ 1387087.238405350130051, 5867648.108302162960172 ], [ 1387180.004647677764297, 5867513.239712204784155 ], [ 1387272.770890005398542, 5867378.373192292638123 ], [ 1387365.537132333032787, 5867243.508742331527174 ], [ 1387458.303374660667032, 5867108.646362232975662 ], [ 1387551.069616988068447, 5867108.646362232975662 ], [ 1387643.835859315935522, 5867108.646362232975662 ], [ 1387736.602101643569767, 5866973.78605190385133 ], [ 1387829.368343971204013, 5866973.78605190385133 ], [ 1387829.368343971204013, 5866838.927811251021922 ], [ 1387829.368343971204013, 5866704.071640183217824 ], [ 1387829.368343971204013, 5866569.217538607306778 ], [ 1387922.134586298838258, 5866434.365506432950497 ], [ 1387922.134586298838258, 5866299.515543567948043 ], [ 1388014.900828626472503, 5866164.667649918235838 ], [ 1388014.900828626472503, 5866029.821825394406915 ], [ 1388014.900828626472503, 5865894.978069902397692 ], [ 1388014.900828626472503, 5865760.136383352801204 ], [ 1387922.134586298838258, 5865625.296765649691224 ], [ 1387922.134586298838258, 5865490.459216705523431 ], [ 1387922.134586298838258, 5865355.623736422508955 ], [ 1387922.134586298838258, 5865220.790324714966118 ], [ 1387922.134586298838258, 5865085.958981488831341 ], [ 1387829.368343971204013, 5864951.129706650041044 ], [ 1387829.368343971204013, 5864816.302500107325613 ], [ 1387829.368343971204013, 5864681.477361769415438 ], [ 1387829.368343971204013, 5864546.654291545972228 ], [ 1387829.368343971204013, 5864411.833289342001081 ], [ 1387829.368343971204013, 5864277.014355068095028 ], [ 1387736.602101643569767, 5864142.197488628327847 ], [ 1387643.835859315935522, 5864007.382689936086535 ], [ 1387551.069616988068447, 5863872.569958896376193 ], [ 1387551.069616988068447, 5863737.759295416995883 ], [ 1387458.303374660667032, 5863602.950699406675994 ], [ 1387365.537132333032787, 5863468.144170773215592 ], [ 1387272.770890005398542, 5863333.339709427207708 ], [ 1387272.770890005398542, 5863198.537315272726119 ], [ 1387180.004647677764297, 5863063.736988220363855 ], [ 1387087.238405350130051, 5862928.938728176057339 ], [ 1386994.472163022495806, 5862794.142535050399601 ], [ 1386901.70592069462873, 5862794.142535050399601 ], [ 1386808.939678366994485, 5862659.348408752121031 ], [ 1386716.17343603936024, 5862524.556349185295403 ], [ 1386716.17343603936024, 5862389.766356259584427 ], [ 1386716.17343603936024, 5862254.978429886512458 ], [ 1386808.939678366994485, 5862254.978429886512458 ], [ 1386901.70592069462873, 5862120.192569970153272 ], [ 1386994.472163022495806, 5862120.192569970153272 ] ] } }, -{ "type": "Feature", "properties": { "height": 21.70001220703125, "width": 50.0, "bedlev": 952.79998779296875, "branchid": "river_3", "branchtype": "river", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_3", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1391540.01803707703948, 5858077.577220032922924 ], [ 1391447.251794749405235, 5858077.577220032922924 ], [ 1391354.48555242177099, 5858077.577220032922924 ], [ 1391261.719310093903914, 5858077.577220032922924 ], [ 1391168.953067766269669, 5858077.577220032922924 ], [ 1391076.186825438635424, 5858212.301128903403878 ], [ 1390983.420583111001179, 5858212.301128903403878 ], [ 1390890.654340783366933, 5858212.301128903403878 ], [ 1390797.888098455965519, 5858077.577220032922924 ], [ 1390705.121856128098443, 5858077.577220032922924 ], [ 1390612.355613800464198, 5858077.577220032922924 ], [ 1390519.589371472829953, 5858077.577220032922924 ], [ 1390426.823129145195708, 5858077.577220032922924 ], [ 1390334.056886817561463, 5857942.855374777689576 ], [ 1390241.290644489927217, 5857942.855374777689576 ], [ 1390148.524402162292972, 5857942.855374777689576 ], [ 1390055.758159834658727, 5857808.135593040846288 ], [ 1389962.991917507024482, 5857808.135593040846288 ], [ 1389962.991917507024482, 5857673.41787473578006 ], [ 1389870.225675179390237, 5857673.41787473578006 ], [ 1389777.459432851755992, 5857673.41787473578006 ], [ 1389684.693190524121746, 5857808.135593040846288 ], [ 1389591.926948196487501, 5857808.135593040846288 ], [ 1389499.160705868853256, 5857808.135593040846288 ], [ 1389406.39446354098618, 5857808.135593040846288 ], [ 1389313.628221213351935, 5857942.855374777689576 ], [ 1389220.86197888571769, 5858077.577220032922924 ], [ 1389128.095736558316275, 5858212.301128903403878 ], [ 1389035.32949423068203, 5858212.301128903403878 ], [ 1388942.563251903047785, 5858347.02710147574544 ], [ 1388849.797009575180709, 5858347.02710147574544 ], [ 1388757.030767247546464, 5858347.02710147574544 ], [ 1388664.264524919912219, 5858481.755137845873833 ], [ 1388571.498282592277974, 5858481.755137845873833 ], [ 1388478.732040264643729, 5858481.755137845873833 ], [ 1388385.965797937009484, 5858481.755137845873833 ], [ 1388293.199555609375238, 5858481.755137845873833 ], [ 1388200.433313281740993, 5858616.485238100402057 ], [ 1388107.667070954106748, 5858751.217402336187661 ], [ 1388014.900828626472503, 5858885.951630645431578 ], [ 1387922.134586298838258, 5858885.951630645431578 ], [ 1387829.368343971204013, 5858885.951630645431578 ], [ 1387736.602101643569767, 5858885.951630645431578 ], [ 1387643.835859315935522, 5858885.951630645431578 ], [ 1387551.069616988068447, 5858885.951630645431578 ], [ 1387458.303374660667032, 5858885.951630645431578 ], [ 1387365.537132333032787, 5858885.951630645431578 ], [ 1387272.770890005398542, 5858885.951630645431578 ], [ 1387180.004647677764297, 5858885.951630645431578 ], [ 1387087.238405350130051, 5858885.951630645431578 ], [ 1386994.472163022495806, 5858885.951630645431578 ], [ 1386901.70592069462873, 5858885.951630645431578 ], [ 1386808.939678366994485, 5858885.951630645431578 ], [ 1386716.17343603936024, 5859020.687923114746809 ], [ 1386623.407193711958826, 5859020.687923114746809 ], [ 1386530.64095138432458, 5859020.687923114746809 ], [ 1386437.874709056690335, 5859020.687923114746809 ], [ 1386345.108466728823259, 5859020.687923114746809 ] ] } }, -{ "type": "Feature", "properties": { "height": 14.050003051757812, "width": 60.93007025, "bedlev": 724.29998779296875, "branchid": "river_4", "branchtype": "river", "branchorder": "1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_4", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386994.472163022495806, 5862120.192569970153272 ], [ 1386901.70592069462873, 5861985.408776421099901 ], [ 1386808.939678366994485, 5861850.627049146220088 ], [ 1386716.17343603936024, 5861715.847388052381575 ], [ 1386716.17343603936024, 5861581.069793051108718 ], [ 1386716.17343603936024, 5861446.294264048337936 ], [ 1386648.271799877518788, 5861347.644815167412162 ] ] } }, -{ "type": "Feature", "properties": { "height": 14.050003051757812, "width": 60.93007025, "bedlev": 724.29998779296875, "branchid": "river_4-1", "branchtype": "river", "branchorder": "1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_4", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386648.271799877518788, 5861347.644815167412162 ], [ 1386623.407193711958826, 5861311.520800951868296 ], [ 1386623.407193711958826, 5861176.749403670430183 ], [ 1386530.64095138432458, 5861176.749403670430183 ], [ 1386437.874709056690335, 5861041.98007211368531 ], [ 1386437.874709056690335, 5860907.212806186638772 ], [ 1386437.874709056690335, 5860772.447605801746249 ], [ 1386437.874709056690335, 5860637.684470863081515 ], [ 1386345.108466728823259, 5860502.92340128030628 ], [ 1386345.108466728823259, 5860368.164396961219609 ], [ 1386252.342224401189014, 5860233.407457816414535 ], [ 1386159.575982073554769, 5860098.652583750896156 ], [ 1386159.575982073554769, 5859963.899774673394859 ], [ 1386159.575982073554769, 5859829.149030494503677 ], [ 1386159.575982073554769, 5859694.40035112015903 ], [ 1386252.342224401189014, 5859559.653736459091306 ], [ 1386252.342224401189014, 5859424.909186420030892 ], [ 1386252.342224401189014, 5859290.166700910776854 ], [ 1386252.342224401189014, 5859155.426279840059578 ], [ 1386345.108466728823259, 5859020.687923114746809 ] ] } }, -{ "type": "Feature", "properties": { "height": 17.349960327148438, "width": 60.93007025, "bedlev": 701.4000244140625, "branchid": "river_5", "branchtype": "river", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_5", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386345.108466728823259, 5859020.687923114746809 ], [ 1386252.342224401189014, 5858885.951630645431578 ], [ 1386159.575982073554769, 5858751.217402336187661 ], [ 1386159.575982073554769, 5858616.485238100402057 ], [ 1386159.575982073554769, 5858481.755137845873833 ], [ 1386159.575982073554769, 5858347.02710147574544 ], [ 1386066.809739745920524, 5858212.301128903403878 ], [ 1385974.043497418286279, 5858212.301128903403878 ], [ 1385881.277255090652034, 5858212.301128903403878 ], [ 1385788.511012763017789, 5858212.301128903403878 ], [ 1385695.744770435383543, 5858212.301128903403878 ], [ 1385602.978528107749298, 5858077.577220032922924 ], [ 1385510.212285780115053, 5857942.855374777689576 ], [ 1385510.212285780115053, 5857808.135593040846288 ], [ 1385417.446043452480808, 5857673.41787473578006 ], [ 1385324.679801124846563, 5857673.41787473578006 ], [ 1385231.913558797212318, 5857538.702219764702022 ], [ 1385231.913558797212318, 5857403.988628041930497 ], [ 1385231.913558797212318, 5857269.277099471539259 ], [ 1385231.913558797212318, 5857134.567633965052664 ], [ 1385324.679801124846563, 5856999.86023142747581 ], [ 1385231.913558797212318, 5856865.154891769401729 ], [ 1385231.913558797212318, 5856730.451614898629487 ], [ 1385139.147316469578072, 5856595.750400722958148 ], [ 1385046.381074141710997, 5856595.750400722958148 ], [ 1384953.614831814309582, 5856461.051249152049422 ], [ 1384860.848589486675337, 5856461.051249152049422 ], [ 1384768.082347159041092, 5856326.354160091839731 ], [ 1384768.082347159041092, 5856191.659133453853428 ], [ 1384675.316104831406847, 5856056.966169144026935 ], [ 1384582.549862503772601, 5856056.966169144026935 ], [ 1384489.783620175905526, 5855922.275267072021961 ], [ 1384397.017377848271281, 5855787.586427145637572 ], [ 1384304.251135520637035, 5855787.586427145637572 ], [ 1384211.48489319300279, 5855652.899649272672832 ], [ 1384118.718650865368545, 5855518.21493336185813 ], [ 1384025.952408537967131, 5855383.532279322855175 ], [ 1383933.186166210100055, 5855248.851687061600387 ], [ 1383840.41992388246581, 5855248.851687061600387 ], [ 1383747.653681554831564, 5855114.1731564886868 ], [ 1383747.653681554831564, 5854979.496687510982156 ], [ 1383747.653681554831564, 5854844.822280039079487 ], [ 1383654.887439227197319, 5854844.822280039079487 ], [ 1383562.121196899563074, 5854710.149933977983892 ], [ 1383469.354954571928829, 5854710.149933977983892 ], [ 1383376.588712244294584, 5854575.479649240151048 ], [ 1383283.822469916660339, 5854440.811425729654729 ], [ 1383191.056227589026093, 5854440.811425729654729 ] ] } } +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_1_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389238.298387300921604, 5860147.714495398104191 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 933.5, "invlev_up": 913.4000244140625, "invlev_dn": 931.0, "manhole_up": "manhole_1_generated", "manhole_dn": "manhole_2_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389238.298387300921604, 5860147.714495398104191 ], [ 1389210.947846550960094, 5860184.343885350972414 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.5, "elevtn_dn": 933.5, "invlev_up": 931.0, "invlev_dn": 931.0, "manhole_up": "manhole_2_generated", "manhole_dn": "manhole_3_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389210.947846550960094, 5860184.343885350972414 ], [ 1389186.961922727525234, 5860223.315261371433735 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.5, "elevtn_dn": 935.5, "invlev_up": 931.0, "invlev_dn": 933.0, "manhole_up": "manhole_3_generated", "manhole_dn": "manhole_4_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389186.961922727525234, 5860223.315261371433735 ], [ 1389162.755598766496405, 5860262.142883376218379 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 935.5, "invlev_up": 933.0, "invlev_dn": 933.0, "manhole_up": "manhole_4_generated", "manhole_dn": "manhole_5_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389162.755598766496405, 5860262.142883376218379 ], [ 1389136.759307563304901, 5860299.80301527120173 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 936.5, "invlev_up": 933.0, "invlev_dn": 934.0, "manhole_up": "manhole_5_generated", "manhole_dn": "manhole_6_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389136.759307563304901, 5860299.80301527120173 ], [ 1389109.7301227634307, 5860336.652257356792688 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 936.5, "elevtn_dn": 941.10003662109375, "invlev_up": 934.0, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_6_generated", "manhole_dn": "manhole_7_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389109.7301227634307, 5860336.652257356792688 ], [ 1389073.18478828552179, 5860363.522737024351954 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_7_generated", "manhole_dn": "manhole_8_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389073.18478828552179, 5860363.522737024351954 ], [ 1389032.546542100608349, 5860384.329287325032055 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_8_generated", "manhole_dn": "manhole_9_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389032.546542100608349, 5860384.329287325032055 ], [ 1388989.578410296700895, 5860400.071978960186243 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 951.29998779296875, "invlev_up": 938.60003662109375, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_9_generated", "manhole_dn": "manhole_10_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388989.578410296700895, 5860400.071978960186243 ], [ 1388946.301100668497384, 5860414.883977899327874 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_11_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389221.905703959986567, 5860123.3256367566064 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_11_generated", "manhole_dn": "manhole_12_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389221.905703959986567, 5860123.3256367566064 ], [ 1389177.295895804418251, 5860134.962970778346062 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 919.60003662109375, "invlev_up": 913.4000244140625, "invlev_dn": 917.10003662109375, "manhole_up": "manhole_12_generated", "manhole_dn": "manhole_13_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389177.295895804418251, 5860134.962970778346062 ], [ 1389132.686087648617104, 5860146.600304800085723 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 919.60003662109375, "elevtn_dn": 919.60003662109375, "invlev_up": 917.10003662109375, "invlev_dn": 917.10003662109375, "manhole_up": "manhole_13_generated", "manhole_dn": "manhole_14_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389132.686087648617104, 5860146.600304800085723 ], [ 1389088.076279493048787, 5860158.237638821825385 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 919.60003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 917.10003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_14_generated", "manhole_dn": "manhole_15_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389088.076279493048787, 5860158.237638821825385 ], [ 1389044.226173994829878, 5860172.143308508209884 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 935.60003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_15_generated", "manhole_dn": "manhole_16_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389044.226173994829878, 5860172.143308508209884 ], [ 1389012.527182487538084, 5860198.239755615592003 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 935.60003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_16_generated", "manhole_dn": "manhole_17_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389012.527182487538084, 5860198.239755615592003 ], [ 1388995.773122631013393, 5860240.481283166445792 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 945.0, "invlev_up": 935.60003662109375, "invlev_dn": 942.5, "manhole_up": "manhole_17_generated", "manhole_dn": "manhole_18_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388995.773122631013393, 5860240.481283166445792 ], [ 1388973.630034049740061, 5860280.918223639950156 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.0, "elevtn_dn": 951.29998779296875, "invlev_up": 942.5, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_18_generated", "manhole_dn": "manhole_19_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388973.630034049740061, 5860280.918223639950156 ], [ 1388961.171157888136804, 5860324.081192856654525 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_19_generated", "manhole_dn": "manhole_20_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388961.171157888136804, 5860324.081192856654525 ], [ 1388955.410555170848966, 5860369.690168970264494 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_20_generated", "manhole_dn": "manhole_10_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388955.410555170848966, 5860369.690168970264494 ], [ 1388946.301100668497384, 5860414.883977899327874 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 914.5, "invlev_up": 913.4000244140625, "invlev_dn": 912.0, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_21_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389306.50000010849908, 5860083.476415127515793 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 914.5, "elevtn_dn": 914.5, "invlev_up": 912.0, "invlev_dn": 912.0, "manhole_up": "manhole_21_generated", "manhole_dn": "manhole_22_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389306.50000010849908, 5860083.476415127515793 ], [ 1389355.420758404070511, 5860074.630405306816101 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 914.5, "elevtn_dn": 929.9000244140625, "invlev_up": 912.0, "invlev_dn": 927.4000244140625, "manhole_up": "manhole_22_generated", "manhole_dn": "manhole_23_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389355.420758404070511, 5860074.630405306816101 ], [ 1389389.090761042200029, 5860042.4449307853356 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 929.9000244140625, "elevtn_dn": 955.0, "invlev_up": 927.4000244140625, "invlev_dn": 952.5, "manhole_up": "manhole_23_generated", "manhole_dn": "manhole_24_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389389.090761042200029, 5860042.4449307853356 ], [ 1389404.036260401364416, 5859994.775433851405978 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_24_generated", "manhole_dn": "manhole_25_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389404.036260401364416, 5859994.775433851405978 ], [ 1389418.744130451697856, 5859947.032028519548476 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_25_generated", "manhole_dn": "manhole_26_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389418.744130451697856, 5859947.032028519548476 ], [ 1389423.265342897269875, 5859897.853969652205706 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 975.29998779296875, "invlev_up": 952.5, "invlev_dn": 972.79998779296875, "manhole_up": "manhole_26_generated", "manhole_dn": "manhole_27_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389423.265342897269875, 5859897.853969652205706 ], [ 1389395.831073811277747, 5859856.743154510855675 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 975.29998779296875, "elevtn_dn": 963.0, "invlev_up": 972.79998779296875, "invlev_dn": 960.5, "manhole_up": "manhole_27_generated", "manhole_dn": "manhole_28_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389395.831073811277747, 5859856.743154510855675 ], [ 1389350.827042841585353, 5859839.640478814020753 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 963.0, "elevtn_dn": 963.0, "invlev_up": 960.5, "invlev_dn": 960.5, "manhole_up": "manhole_28_generated", "manhole_dn": "manhole_29_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389350.827042841585353, 5859839.640478814020753 ], [ 1389303.795788601972163, 5859855.887689013034105 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 963.0, "elevtn_dn": 945.4000244140625, "invlev_up": 960.5, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_29_generated", "manhole_dn": "manhole_30_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389303.795788601972163, 5859855.887689013034105 ], [ 1389256.284586790716276, 5859863.631580747663975 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 945.4000244140625, "invlev_up": 942.9000244140625, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_30_generated", "manhole_dn": "manhole_31_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389256.284586790716276, 5859863.631580747663975 ], [ 1389227.308454349869862, 5859823.781623384915292 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 945.4000244140625, "invlev_up": 942.9000244140625, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_31_generated", "manhole_dn": "manhole_32_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389227.308454349869862, 5859823.781623384915292 ], [ 1389202.745489193825051, 5859780.279727600514889 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 959.10003662109375, "invlev_up": 942.9000244140625, "invlev_dn": 956.60003662109375, "manhole_up": "manhole_32_generated", "manhole_dn": "manhole_33_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389202.745489193825051, 5859780.279727600514889 ], [ 1389178.18252403778024, 5859736.777831817045808 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 959.10003662109375, "elevtn_dn": 944.79998779296875, "invlev_up": 956.60003662109375, "invlev_dn": 942.29998779296875, "manhole_up": "manhole_33_generated", "manhole_dn": "manhole_34_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389178.18252403778024, 5859736.777831817045808 ], [ 1389155.231297271326184, 5859692.450142606161535 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 944.79998779296875, "elevtn_dn": 944.79998779296875, "invlev_up": 942.29998779296875, "invlev_dn": 942.29998779296875, "manhole_up": "manhole_34_generated", "manhole_dn": "manhole_35_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389155.231297271326184, 5859692.450142606161535 ], [ 1389141.413412723457441, 5859644.883844587020576 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 944.79998779296875, "elevtn_dn": 952.4000244140625, "invlev_up": 942.29998779296875, "invlev_dn": 949.9000244140625, "manhole_up": "manhole_35_generated", "manhole_dn": "manhole_36_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389141.413412723457441, 5859644.883844587020576 ], [ 1389151.802280035568401, 5859598.61804121825844 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.4000244140625, "elevtn_dn": 960.70001220703125, "invlev_up": 949.9000244140625, "invlev_dn": 958.20001220703125, "manhole_up": "manhole_36_generated", "manhole_dn": "manhole_37_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389151.802280035568401, 5859598.61804121825844 ], [ 1389191.073854762827978, 5859569.046822287142277 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 960.70001220703125, "elevtn_dn": 960.70001220703125, "invlev_up": 958.20001220703125, "invlev_dn": 958.20001220703125, "manhole_up": "manhole_37_generated", "manhole_dn": "manhole_38_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389191.073854762827978, 5859569.046822287142277 ], [ 1389239.915165816899389, 5859563.955490378662944 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 960.70001220703125, "elevtn_dn": 969.60003662109375, "invlev_up": 958.20001220703125, "invlev_dn": 967.10003662109375, "manhole_up": "manhole_38_generated", "manhole_dn": "manhole_39_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389239.915165816899389, 5859563.955490378662944 ], [ 1389289.757686472963542, 5859566.285022127442062 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 969.60003662109375, "elevtn_dn": 969.60003662109375, "invlev_up": 967.10003662109375, "invlev_dn": 967.10003662109375, "manhole_up": "manhole_39_generated", "manhole_dn": "manhole_40_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389289.757686472963542, 5859566.285022127442062 ], [ 1389339.615828452631831, 5859566.079234052449465 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 969.60003662109375, "elevtn_dn": 976.29998779296875, "invlev_up": 967.10003662109375, "invlev_dn": 973.79998779296875, "manhole_up": "manhole_40_generated", "manhole_dn": "manhole_41_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389339.615828452631831, 5859566.079234052449465 ], [ 1389387.354307833593339, 5859551.676988741382957 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 976.29998779296875, "elevtn_dn": 976.29998779296875, "invlev_up": 973.79998779296875, "invlev_dn": 973.79998779296875, "manhole_up": "manhole_41_generated", "manhole_dn": "manhole_42_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389387.354307833593339, 5859551.676988741382957 ], [ 1389428.692968821851537, 5859524.248876142315567 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 976.29998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 973.79998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_42_generated", "manhole_dn": "manhole_43_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389428.692968821851537, 5859524.248876142315567 ], [ 1389461.138921525795013, 5859486.477508954703808 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_43_generated", "manhole_dn": "manhole_44_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389461.138921525795013, 5859486.477508954703808 ], [ 1389482.45163832209073, 5859441.487986368127167 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_44_generated", "manhole_dn": "manhole_45_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389482.45163832209073, 5859441.487986368127167 ], [ 1389497.215460168197751, 5859393.906833835877478 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_45_generated", "manhole_dn": "manhole_46_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389497.215460168197751, 5859393.906833835877478 ], [ 1389508.394423164660111, 5859345.216126504354179 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 954.79998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_46_generated", "manhole_dn": "manhole_47_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389508.394423164660111, 5859345.216126504354179 ], [ 1389518.522437864448875, 5859296.29671473056078 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 954.79998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_47_generated", "manhole_dn": "manhole_48_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389518.522437864448875, 5859296.29671473056078 ], [ 1389528.588071504374966, 5859247.363727764226496 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 950.20001220703125, "invlev_up": 954.79998779296875, "invlev_dn": 947.70001220703125, "manhole_up": "manhole_48_generated", "manhole_dn": "manhole_49_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389528.588071504374966, 5859247.363727764226496 ], [ 1389538.653705144301057, 5859198.43074079696089 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 950.20001220703125, "elevtn_dn": 957.60003662109375, "invlev_up": 947.70001220703125, "invlev_dn": 955.10003662109375, "manhole_up": "manhole_49_generated", "manhole_dn": "manhole_50_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389538.653705144301057, 5859198.43074079696089 ], [ 1389548.719338784459978, 5859149.497753830626607 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.60003662109375, "elevtn_dn": 957.60003662109375, "invlev_up": 955.10003662109375, "invlev_dn": 955.10003662109375, "manhole_up": "manhole_50_generated", "manhole_dn": "manhole_51_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389548.719338784459978, 5859149.497753830626607 ], [ 1389558.784972424386069, 5859100.564766863361001 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.60003662109375, "elevtn_dn": 954.79998779296875, "invlev_up": 955.10003662109375, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_51_generated", "manhole_dn": "manhole_52_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389558.784972424386069, 5859100.564766863361001 ], [ 1389568.85060606431216, 5859051.631779897026718 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 954.79998779296875, "invlev_up": 952.29998779296875, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_52_generated", "manhole_dn": "manhole_53_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389568.85060606431216, 5859051.631779897026718 ], [ 1389578.916239704471081, 5859002.698792929761112 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 954.79998779296875, "invlev_up": 952.29998779296875, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_53_generated", "manhole_dn": "manhole_54_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389578.916239704471081, 5859002.698792929761112 ], [ 1389588.981873344397172, 5858953.765805963426828 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 956.10003662109375, "invlev_up": 952.29998779296875, "invlev_dn": 953.60003662109375, "manhole_up": "manhole_54_generated", "manhole_dn": "manhole_55_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389588.981873344397172, 5858953.765805963426828 ], [ 1389599.047506984323263, 5858904.832818996161222 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 956.10003662109375, "elevtn_dn": 956.10003662109375, "invlev_up": 953.60003662109375, "invlev_dn": 953.60003662109375, "manhole_up": "manhole_55_generated", "manhole_dn": "manhole_56_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389599.047506984323263, 5858904.832818996161222 ], [ 1389613.243873829254881, 5858857.048414096236229 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 956.10003662109375, "elevtn_dn": 966.29998779296875, "invlev_up": 953.60003662109375, "invlev_dn": 963.79998779296875, "manhole_up": "manhole_56_generated", "manhole_dn": "manhole_57_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389613.243873829254881, 5858857.048414096236229 ], [ 1389631.198101107496768, 5858810.554778259247541 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 966.29998779296875, "elevtn_dn": 968.70001220703125, "invlev_up": 963.79998779296875, "invlev_dn": 966.20001220703125, "manhole_up": "manhole_57_generated", "manhole_dn": "manhole_58_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389631.198101107496768, 5858810.554778259247541 ], [ 1389656.490605737781152, 5858767.472956065088511 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.70001220703125, "elevtn_dn": 968.70001220703125, "invlev_up": 966.20001220703125, "invlev_dn": 966.20001220703125, "manhole_up": "manhole_58_generated", "manhole_dn": "manhole_59_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389656.490605737781152, 5858767.472956065088511 ], [ 1389681.956975018838421, 5858724.49639992788434 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.70001220703125, "elevtn_dn": 976.10003662109375, "invlev_up": 966.20001220703125, "invlev_dn": 973.60003662109375, "manhole_up": "manhole_59_generated", "manhole_dn": "manhole_60_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389681.956975018838421, 5858724.49639992788434 ], [ 1389708.407580326776952, 5858682.115747822448611 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 976.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 973.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_60_generated", "manhole_dn": "manhole_61_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389708.407580326776952, 5858682.115747822448611 ], [ 1389734.858185634715483, 5858639.735095717012882 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 980.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_61_generated", "manhole_dn": "manhole_62_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389734.858185634715483, 5858639.735095717012882 ], [ 1389761.308790942654014, 5858597.354443610645831 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 980.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_62_generated", "manhole_dn": "manhole_63_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389761.308790942654014, 5858597.354443610645831 ], [ 1389787.759396250825375, 5858554.973791505210102 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 993.29998779296875, "invlev_up": 980.60003662109375, "invlev_dn": 990.79998779296875, "manhole_up": "manhole_63_generated", "manhole_dn": "manhole_64_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389787.759396250825375, 5858554.973791505210102 ], [ 1389814.210001558763906, 5858512.593139399774373 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 993.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 990.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_64_generated", "manhole_dn": "manhole_65_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389814.210001558763906, 5858512.593139399774373 ], [ 1389840.660606866702437, 5858470.212487293407321 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 995.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_65_generated", "manhole_dn": "manhole_66_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389840.660606866702437, 5858470.212487293407321 ], [ 1389867.111212174640968, 5858427.831835187971592 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 995.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_66_generated", "manhole_dn": "manhole_67_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389867.111212174640968, 5858427.831835187971592 ], [ 1389911.240854029776528, 5858417.074701879173517 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 1006.2000122070312, "invlev_up": 995.79998779296875, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_67_generated", "manhole_dn": "manhole_68_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389911.240854029776528, 5858417.074701879173517 ], [ 1389940.226093058940023, 5858455.739661679603159 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E48", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1006.2000122070312, "invlev_up": 1003.7000122070312, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_68_generated", "manhole_dn": "manhole_69_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389940.226093058940023, 5858455.739661679603159 ], [ 1389959.842267287895083, 5858501.684845351614058 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E49", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1006.2000122070312, "invlev_up": 1003.7000122070312, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_69_generated", "manhole_dn": "manhole_70_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389959.842267287895083, 5858501.684845351614058 ], [ 1389983.028926897095516, 5858544.760824581608176 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E50", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1036.9000244140625, "invlev_up": 1003.7000122070312, "invlev_dn": 1034.4000244140625, "manhole_up": "manhole_70_generated", "manhole_dn": "manhole_71_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389983.028926897095516, 5858544.760824581608176 ], [ 1390026.879799408372492, 5858567.986969069577754 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E51", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1036.9000244140625, "elevtn_dn": 1036.9000244140625, "invlev_up": 1034.4000244140625, "invlev_dn": 1034.4000244140625, "manhole_up": "manhole_71_generated", "manhole_dn": "manhole_72_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390026.879799408372492, 5858567.986969069577754 ], [ 1390075.455719914287329, 5858577.981817713007331 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E52", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1036.9000244140625, "elevtn_dn": 1032.9000244140625, "invlev_up": 1034.4000244140625, "invlev_dn": 1030.4000244140625, "manhole_up": "manhole_72_generated", "manhole_dn": "manhole_73_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390075.455719914287329, 5858577.981817713007331 ], [ 1390124.934819511603564, 5858584.860858413390815 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E53", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1032.9000244140625, "elevtn_dn": 1032.9000244140625, "invlev_up": 1030.4000244140625, "invlev_dn": 1030.4000244140625, "manhole_up": "manhole_73_generated", "manhole_dn": "manhole_74_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390124.934819511603564, 5858584.860858413390815 ], [ 1390174.385966305155307, 5858591.894069475121796 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E54", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1032.9000244140625, "elevtn_dn": 1016.6000366210938, "invlev_up": 1030.4000244140625, "invlev_dn": 1014.1000366210938, "manhole_up": "manhole_74_generated", "manhole_dn": "manhole_75_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390174.385966305155307, 5858591.894069475121796 ], [ 1390224.28731826832518, 5858594.262458441779017 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E55", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1016.6000366210938, "elevtn_dn": 1016.6000366210938, "invlev_up": 1014.1000366210938, "invlev_dn": 1014.1000366210938, "manhole_up": "manhole_75_generated", "manhole_dn": "manhole_76_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390224.28731826832518, 5858594.262458441779017 ], [ 1390273.630285855382681, 5858589.561945637688041 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E56", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1016.6000366210938, "elevtn_dn": 1012.1000366210938, "invlev_up": 1014.1000366210938, "invlev_dn": 1009.6000366210938, "manhole_up": "manhole_76_generated", "manhole_dn": "manhole_77_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390273.630285855382681, 5858589.561945637688041 ], [ 1390322.239480242831632, 5858578.072306710295379 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E57", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1012.1000366210938, "elevtn_dn": 1012.1000366210938, "invlev_up": 1009.6000366210938, "invlev_dn": 1009.6000366210938, "manhole_up": "manhole_77_generated", "manhole_dn": "manhole_78_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390322.239480242831632, 5858578.072306710295379 ], [ 1390371.99352877959609, 5858575.309522898867726 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E58", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1012.1000366210938, "elevtn_dn": 1011.7000122070312, "invlev_up": 1009.6000366210938, "invlev_dn": 1009.2000122070312, "manhole_up": "manhole_78_generated", "manhole_dn": "manhole_79_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390371.99352877959609, 5858575.309522898867726 ], [ 1390419.13544210139662, 5858559.59311543405056 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E59", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1011.7000122070312, "elevtn_dn": 981.5, "invlev_up": 1009.2000122070312, "invlev_dn": 979.0, "manhole_up": "manhole_79_generated", "manhole_dn": "manhole_80_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390419.13544210139662, 5858559.59311543405056 ], [ 1390453.401623640675098, 5858524.246223840862513 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E60", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 981.5, "elevtn_dn": 995.70001220703125, "invlev_up": 979.0, "invlev_dn": 993.20001220703125, "manhole_up": "manhole_80_generated", "manhole_dn": "manhole_81_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390453.401623640675098, 5858524.246223840862513 ], [ 1390496.749499944737181, 5858504.780008735135198 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E61", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 995.70001220703125, "elevtn_dn": 995.70001220703125, "invlev_up": 993.20001220703125, "invlev_dn": 993.20001220703125, "manhole_up": "manhole_81_generated", "manhole_dn": "manhole_82_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390496.749499944737181, 5858504.780008735135198 ], [ 1390546.470755147282034, 5858499.993151630274951 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E62", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 995.70001220703125, "elevtn_dn": 1005.9000244140625, "invlev_up": 993.20001220703125, "invlev_dn": 1003.4000244140625, "manhole_up": "manhole_82_generated", "manhole_dn": "manhole_83_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390546.470755147282034, 5858499.993151630274951 ], [ 1390596.395264241611585, 5858498.177226040512323 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E63", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1005.9000244140625, "elevtn_dn": 1005.9000244140625, "invlev_up": 1003.4000244140625, "invlev_dn": 1003.4000244140625, "manhole_up": "manhole_83_generated", "manhole_dn": "manhole_84_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390596.395264241611585, 5858498.177226040512323 ], [ 1390646.319773336173967, 5858496.361300451681018 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E64", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1005.9000244140625, "elevtn_dn": 1013.6000366210938, "invlev_up": 1003.4000244140625, "invlev_dn": 1011.1000366210938, "manhole_up": "manhole_84_generated", "manhole_dn": "manhole_85_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390646.319773336173967, 5858496.361300451681018 ], [ 1390696.244282430503517, 5858494.545374862849712 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E65", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1013.6000366210938, "elevtn_dn": 1013.6000366210938, "invlev_up": 1011.1000366210938, "invlev_dn": 1011.1000366210938, "manhole_up": "manhole_85_generated", "manhole_dn": "manhole_86_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390696.244282430503517, 5858494.545374862849712 ], [ 1390746.168791524833068, 5858492.729449273087084 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E66", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1013.6000366210938, "elevtn_dn": 1019.1000366210938, "invlev_up": 1011.1000366210938, "invlev_dn": 1016.6000366210938, "manhole_up": "manhole_86_generated", "manhole_dn": "manhole_87_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390746.168791524833068, 5858492.729449273087084 ], [ 1390796.09330061939545, 5858490.913523684255779 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E67", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1019.1000366210938, "elevtn_dn": 1025.800048828125, "invlev_up": 1016.6000366210938, "invlev_dn": 1023.300048828125, "manhole_up": "manhole_87_generated", "manhole_dn": "manhole_88_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390796.09330061939545, 5858490.913523684255779 ], [ 1390846.017809713725001, 5858489.097598095424473 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E68", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1025.800048828125, "elevtn_dn": 1025.800048828125, "invlev_up": 1023.300048828125, "invlev_dn": 1023.300048828125, "manhole_up": "manhole_88_generated", "manhole_dn": "manhole_89_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390846.017809713725001, 5858489.097598095424473 ], [ 1390895.942318808054551, 5858487.281672505661845 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E69", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1025.800048828125, "elevtn_dn": 1029.2000732421875, "invlev_up": 1023.300048828125, "invlev_dn": 1026.7000732421875, "manhole_up": "manhole_89_generated", "manhole_dn": "manhole_90_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390895.942318808054551, 5858487.281672505661845 ], [ 1390945.364988021552563, 5858492.061225635930896 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E70", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1029.2000732421875, "elevtn_dn": 1029.2000732421875, "invlev_up": 1026.7000732421875, "invlev_dn": 1026.7000732421875, "manhole_up": "manhole_90_generated", "manhole_dn": "manhole_91_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390945.364988021552563, 5858492.061225635930896 ], [ 1390994.440001817885786, 5858501.409873396158218 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E71", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1029.2000732421875, "elevtn_dn": 1033.2000732421875, "invlev_up": 1026.7000732421875, "invlev_dn": 1030.7000732421875, "manhole_up": "manhole_91_generated", "manhole_dn": "manhole_92_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390994.440001817885786, 5858501.409873396158218 ], [ 1391040.341196772176772, 5858520.979841153137386 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E72", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1033.2000732421875, "elevtn_dn": 1033.2000732421875, "invlev_up": 1030.7000732421875, "invlev_dn": 1030.7000732421875, "manhole_up": "manhole_92_generated", "manhole_dn": "manhole_93_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391040.341196772176772, 5858520.979841153137386 ], [ 1391086.683747049886733, 5858538.717575071379542 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E73", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1033.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1030.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_93_generated", "manhole_dn": "manhole_94_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391086.683747049886733, 5858538.717575071379542 ], [ 1391131.822940095094964, 5858523.93243224080652 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E74", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_94_generated", "manhole_dn": "manhole_95_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391131.822940095094964, 5858523.93243224080652 ], [ 1391153.157672074623406, 5858479.460670891217887 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E75", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_95_generated", "manhole_dn": "manhole_96_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391153.157672074623406, 5858479.460670891217887 ], [ 1391192.49590603238903, 5858451.67839205916971 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E76", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1044.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1041.7000732421875, "manhole_up": "manhole_96_generated", "manhole_dn": "manhole_97_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391192.49590603238903, 5858451.67839205916971 ], [ 1391240.64117361814715, 5858438.460245226509869 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E77", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1044.2000732421875, "elevtn_dn": 1044.2000732421875, "invlev_up": 1041.7000732421875, "invlev_dn": 1041.7000732421875, "manhole_up": "manhole_97_generated", "manhole_dn": "manhole_98_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391240.64117361814715, 5858438.460245226509869 ], [ 1391289.211760010803118, 5858426.770406410098076 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E78", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1044.2000732421875, "elevtn_dn": 1060.0999755859375, "invlev_up": 1041.7000732421875, "invlev_dn": 1057.5999755859375, "manhole_up": "manhole_98_generated", "manhole_dn": "manhole_99_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391289.211760010803118, 5858426.770406410098076 ], [ 1391337.782346403226256, 5858415.080567593686283 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E79", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1060.0999755859375, "elevtn_dn": 1023.0, "invlev_up": 1057.5999755859375, "invlev_dn": 1020.5, "manhole_up": "manhole_99_generated", "manhole_dn": "manhole_100_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391337.782346403226256, 5858415.080567593686283 ], [ 1391386.352932795882225, 5858403.390728777274489 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E80", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1023.0, "elevtn_dn": 1032.7000732421875, "invlev_up": 1020.5, "invlev_dn": 1030.2000732421875, "manhole_up": "manhole_100_generated", "manhole_dn": "manhole_101_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391386.352932795882225, 5858403.390728777274489 ], [ 1391434.923519188305363, 5858391.700889961794019 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E81", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1032.7000732421875, "elevtn_dn": 1032.7000732421875, "invlev_up": 1030.2000732421875, "invlev_dn": 1030.2000732421875, "manhole_up": "manhole_101_generated", "manhole_dn": "manhole_102_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391434.923519188305363, 5858391.700889961794019 ], [ 1391483.494105580961332, 5858380.011051145382226 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E82", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1032.7000732421875, "elevtn_dn": 1040.7000732421875, "invlev_up": 1030.2000732421875, "invlev_dn": 1038.2000732421875, "manhole_up": "manhole_102_generated", "manhole_dn": "manhole_103_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391483.494105580961332, 5858380.011051145382226 ], [ 1391532.464345134794712, 5858375.802092345431447 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E83", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1040.7000732421875, "elevtn_dn": 1040.7000732421875, "invlev_up": 1038.2000732421875, "invlev_dn": 1038.2000732421875, "manhole_up": "manhole_103_generated", "manhole_dn": "manhole_104_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391532.464345134794712, 5858375.802092345431447 ], [ 1391579.680508555145934, 5858389.753166117705405 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E84", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1040.7000732421875, "elevtn_dn": 1094.5999755859375, "invlev_up": 1038.2000732421875, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_104_generated", "manhole_dn": "manhole_105_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391579.680508555145934, 5858389.753166117705405 ], [ 1391615.043221722124144, 5858422.374543751589954 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E85", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1094.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_105_generated", "manhole_dn": "manhole_106_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391615.043221722124144, 5858422.374543751589954 ], [ 1391633.654095822479576, 5858468.206737855449319 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E86", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1094.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_106_generated", "manhole_dn": "manhole_107_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391633.654095822479576, 5858468.206737855449319 ], [ 1391675.556871910346672, 5858492.042518986389041 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E87", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1100.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1098.0999755859375, "manhole_up": "manhole_107_generated", "manhole_dn": "manhole_108_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391675.556871910346672, 5858492.042518986389041 ], [ 1391725.165284683462232, 5858493.223410680890083 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E88", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1100.5999755859375, "elevtn_dn": 1092.7000732421875, "invlev_up": 1098.0999755859375, "invlev_dn": 1090.2000732421875, "manhole_up": "manhole_108_generated", "manhole_dn": "manhole_109_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391725.165284683462232, 5858493.223410680890083 ], [ 1391774.025632579578087, 5858482.968163449317217 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E89", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1092.7000732421875, "elevtn_dn": 1092.7000732421875, "invlev_up": 1090.2000732421875, "invlev_dn": 1090.2000732421875, "manhole_up": "manhole_109_generated", "manhole_dn": "manhole_110_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391774.025632579578087, 5858482.968163449317217 ], [ 1391822.748904443578795, 5858472.800456050783396 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E90", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1092.7000732421875, "elevtn_dn": 1086.5, "invlev_up": 1090.2000732421875, "invlev_dn": 1084.0, "manhole_up": "manhole_110_generated", "manhole_dn": "manhole_111_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391822.748904443578795, 5858472.800456050783396 ], [ 1391872.520155652426183, 5858474.254766616038978 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E91", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1086.5, "elevtn_dn": 1086.5, "invlev_up": 1084.0, "invlev_dn": 1084.0, "manhole_up": "manhole_111_generated", "manhole_dn": "manhole_112_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391872.520155652426183, 5858474.254766616038978 ], [ 1391922.32820742437616, 5858478.116394865326583 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E92", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1086.5, "elevtn_dn": 1097.300048828125, "invlev_up": 1084.0, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_112_generated", "manhole_dn": "manhole_113_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391922.32820742437616, 5858478.116394865326583 ], [ 1391972.136259196558967, 5858481.978023114614189 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E93", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_113_generated", "manhole_dn": "manhole_114_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391972.136259196558967, 5858481.978023114614189 ], [ 1392014.088137687649578, 5858507.265420926734805 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E94", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_114_generated", "manhole_dn": "manhole_115_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392014.088137687649578, 5858507.265420926734805 ], [ 1392052.00577615830116, 5858538.949620860628784 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E95", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_115_generated", "manhole_dn": "manhole_116_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392052.00577615830116, 5858538.949620860628784 ], [ 1392100.993319420609623, 5858548.746293722651899 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E96", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1135.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1132.800048828125, "manhole_up": "manhole_116_generated", "manhole_dn": "manhole_117_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392100.993319420609623, 5858548.746293722651899 ], [ 1392149.980862683150917, 5858558.542966585606337 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E97", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1135.300048828125, "elevtn_dn": 1135.300048828125, "invlev_up": 1132.800048828125, "invlev_dn": 1132.800048828125, "manhole_up": "manhole_117_generated", "manhole_dn": "manhole_118_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392149.980862683150917, 5858558.542966585606337 ], [ 1392198.767287699971348, 5858569.25206732749939 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E98", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1135.300048828125, "elevtn_dn": 1137.5999755859375, "invlev_up": 1132.800048828125, "invlev_dn": 1135.0999755859375, "manhole_up": "manhole_118_generated", "manhole_dn": "manhole_119_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392198.767287699971348, 5858569.25206732749939 ], [ 1392247.333906656363979, 5858580.958378325216472 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E99", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1137.5999755859375, "elevtn_dn": 1137.5999755859375, "invlev_up": 1135.0999755859375, "invlev_dn": 1135.0999755859375, "manhole_up": "manhole_119_generated", "manhole_dn": "manhole_120_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392247.333906656363979, 5858580.958378325216472 ], [ 1392295.900525612989441, 5858592.664689323864877 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E100", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1137.5999755859375, "elevtn_dn": 1145.0999755859375, "invlev_up": 1135.0999755859375, "invlev_dn": 1142.5999755859375, "manhole_up": "manhole_120_generated", "manhole_dn": "manhole_121_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392295.900525612989441, 5858592.664689323864877 ], [ 1392344.467144569614902, 5858604.371000322513282 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E101", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1145.0999755859375, "elevtn_dn": 1145.0999755859375, "invlev_up": 1142.5999755859375, "invlev_dn": 1142.5999755859375, "manhole_up": "manhole_121_generated", "manhole_dn": "manhole_122_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392344.467144569614902, 5858604.371000322513282 ], [ 1392389.908255772199482, 5858624.575613909401 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E102", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1145.0999755859375, "elevtn_dn": 1140.5, "invlev_up": 1142.5999755859375, "invlev_dn": 1138.0, "manhole_up": "manhole_122_generated", "manhole_dn": "manhole_123_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392389.908255772199482, 5858624.575613909401 ], [ 1392425.081700494978577, 5858659.315580372698605 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E103", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1140.5, "elevtn_dn": 1169.300048828125, "invlev_up": 1138.0, "invlev_dn": 1166.800048828125, "manhole_up": "manhole_123_generated", "manhole_dn": "manhole_124_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392425.081700494978577, 5858659.315580372698605 ], [ 1392458.203119478421286, 5858696.715123130939901 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E104", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.300048828125, "elevtn_dn": 1169.300048828125, "invlev_up": 1166.800048828125, "invlev_dn": 1166.800048828125, "manhole_up": "manhole_124_generated", "manhole_dn": "manhole_125_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392458.203119478421286, 5858696.715123130939901 ], [ 1392491.324538461863995, 5858734.114665890112519 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E105", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.300048828125, "elevtn_dn": 1165.5, "invlev_up": 1166.800048828125, "invlev_dn": 1163.0, "manhole_up": "manhole_125_generated", "manhole_dn": "manhole_126_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392491.324538461863995, 5858734.114665890112519 ], [ 1392528.963966277893633, 5858766.460637149401009 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E106", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1165.5, "elevtn_dn": 1165.5, "invlev_up": 1163.0, "invlev_dn": 1163.0, "manhole_up": "manhole_126_generated", "manhole_dn": "manhole_127_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392528.963966277893633, 5858766.460637149401009 ], [ 1392573.284122244687751, 5858789.391092935577035 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E107", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1165.5, "elevtn_dn": 1157.0999755859375, "invlev_up": 1163.0, "invlev_dn": 1154.5999755859375, "manhole_up": "manhole_127_generated", "manhole_dn": "manhole_128_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392573.284122244687751, 5858789.391092935577035 ], [ 1392618.033192394766957, 5858811.600886153057218 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E108", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1157.0999755859375, "elevtn_dn": 1184.800048828125, "invlev_up": 1154.5999755859375, "invlev_dn": 1182.300048828125, "manhole_up": "manhole_128_generated", "manhole_dn": "manhole_129_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392618.033192394766957, 5858811.600886153057218 ], [ 1392666.730896146036685, 5858821.011833874508739 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E109", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1184.800048828125, "elevtn_dn": 1141.2000732421875, "invlev_up": 1182.300048828125, "invlev_dn": 1138.7000732421875, "manhole_up": "manhole_129_generated", "manhole_dn": "manhole_130_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392666.730896146036685, 5858821.011833874508739 ], [ 1392714.397227015113458, 5858809.184477739967406 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E110", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1141.2000732421875, "elevtn_dn": 1141.2000732421875, "invlev_up": 1138.7000732421875, "invlev_dn": 1138.7000732421875, "manhole_up": "manhole_130_generated", "manhole_dn": "manhole_131_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392714.397227015113458, 5858809.184477739967406 ], [ 1392761.799294820055366, 5858794.231293976306915 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E111", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1141.2000732421875, "elevtn_dn": 1137.4000244140625, "invlev_up": 1138.7000732421875, "invlev_dn": 1134.9000244140625, "manhole_up": "manhole_131_generated", "manhole_dn": "manhole_132_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392761.799294820055366, 5858794.231293976306915 ], [ 1392810.095712865469977, 5858797.830352782271802 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E112", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1137.4000244140625, "elevtn_dn": 1137.4000244140625, "invlev_up": 1134.9000244140625, "invlev_dn": 1134.9000244140625, "manhole_up": "manhole_132_generated", "manhole_dn": "manhole_133_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392810.095712865469977, 5858797.830352782271802 ], [ 1392855.660074200481176, 5858817.529770986177027 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E113", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1137.4000244140625, "elevtn_dn": 1169.5, "invlev_up": 1134.9000244140625, "invlev_dn": 1167.0, "manhole_up": "manhole_133_generated", "manhole_dn": "manhole_134_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392855.660074200481176, 5858817.529770986177027 ], [ 1392904.672455, 5858826.347064822912216 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E114", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_134_generated", "manhole_dn": "manhole_135_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392904.672455, 5858826.347064822912216 ], [ 1392949.505032581742853, 5858846.393358059227467 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E115", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_135_generated", "manhole_dn": "manhole_136_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392949.505032581742853, 5858846.393358059227467 ], [ 1392993.956312821945176, 5858868.358838438987732 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E116", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_136_generated", "manhole_dn": "manhole_137_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392993.956312821945176, 5858868.358838438987732 ], [ 1393042.160067020915449, 5858881.479519641026855 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E117", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1162.0, "invlev_up": 1167.0, "invlev_dn": 1159.5, "manhole_up": "manhole_137_generated", "manhole_dn": "manhole_138_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393042.160067020915449, 5858881.479519641026855 ], [ 1393090.363821219652891, 5858894.600200843065977 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E118", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1162.0, "elevtn_dn": 1162.0, "invlev_up": 1159.5, "invlev_dn": 1159.5, "manhole_up": "manhole_138_generated", "manhole_dn": "manhole_139_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393090.363821219652891, 5858894.600200843065977 ], [ 1393138.877780271228403, 5858905.382868006825447 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E119", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1162.0, "elevtn_dn": 1152.0999755859375, "invlev_up": 1159.5, "invlev_dn": 1149.5999755859375, "manhole_up": "manhole_139_generated", "manhole_dn": "manhole_140_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393138.877780271228403, 5858905.382868006825447 ], [ 1393188.835210436256602, 5858905.286093098111451 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E120", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1152.0999755859375, "elevtn_dn": 1152.0999755859375, "invlev_up": 1149.5999755859375, "invlev_dn": 1149.5999755859375, "manhole_up": "manhole_140_generated", "manhole_dn": "manhole_141_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393188.835210436256602, 5858905.286093098111451 ], [ 1393237.248238409170881, 5858916.599204055964947 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E121", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1152.0999755859375, "elevtn_dn": 1147.300048828125, "invlev_up": 1149.5999755859375, "invlev_dn": 1144.800048828125, "manhole_up": "manhole_141_generated", "manhole_dn": "manhole_142_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393237.248238409170881, 5858916.599204055964947 ], [ 1393278.15638761385344, 5858943.766047672368586 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E122", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1147.300048828125, "elevtn_dn": 1182.7000732421875, "invlev_up": 1144.800048828125, "invlev_dn": 1180.2000732421875, "manhole_up": "manhole_142_generated", "manhole_dn": "manhole_143_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393278.15638761385344, 5858943.766047672368586 ], [ 1393316.553906054003164, 5858975.725158606655896 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E123", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1182.7000732421875, "elevtn_dn": 1180.0999755859375, "invlev_up": 1180.2000732421875, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_143_generated", "manhole_dn": "manhole_144_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393316.553906054003164, 5858975.725158606655896 ], [ 1393354.951424494385719, 5859007.684269540011883 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E124", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1180.0999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_144_generated", "manhole_dn": "manhole_145_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393354.951424494385719, 5859007.684269540011883 ], [ 1393393.348942934535444, 5859039.643380474299192 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E125", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1180.0999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_145_generated", "manhole_dn": "manhole_146_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393393.348942934535444, 5859039.643380474299192 ], [ 1393431.746461374685168, 5859071.602491408586502 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E126", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_146_generated", "manhole_dn": "manhole_147_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393431.746461374685168, 5859071.602491408586502 ], [ 1393472.672340910183266, 5859100.089053857140243 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E127", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1200.0999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_147_generated", "manhole_dn": "manhole_148_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393472.672340910183266, 5859100.089053857140243 ], [ 1393507.678647378925234, 5859134.262682756409049 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E128", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1200.0999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_148_generated", "manhole_dn": "manhole_149_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393507.678647378925234, 5859134.262682756409049 ], [ 1393492.637579936999828, 5859179.667013085447252 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E129", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1232.300048828125, "invlev_up": 1200.0999755859375, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_149_generated", "manhole_dn": "manhole_150_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393492.637579936999828, 5859179.667013085447252 ], [ 1393472.727902054553851, 5859225.064155456610024 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E130", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_150_generated", "manhole_dn": "manhole_151_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393472.727902054553851, 5859225.064155456610024 ], [ 1393467.563765458529815, 5859274.587596206925809 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E131", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_151_generated", "manhole_dn": "manhole_152_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393467.563765458529815, 5859274.587596206925809 ], [ 1393473.51405850565061, 5859323.8850102070719 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E132", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_152_generated", "manhole_dn": "manhole_153_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393473.51405850565061, 5859323.8850102070719 ], [ 1393507.773820924572647, 5859356.614802500233054 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E133", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1214.800048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1212.300048828125, "manhole_up": "manhole_153_generated", "manhole_dn": "manhole_154_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393507.773820924572647, 5859356.614802500233054 ], [ 1393555.824224345618859, 5859349.253152369521558 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E134", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1214.800048828125, "elevtn_dn": 1214.800048828125, "invlev_up": 1212.300048828125, "invlev_dn": 1212.300048828125, "manhole_up": "manhole_154_generated", "manhole_dn": "manhole_155_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393555.824224345618859, 5859349.253152369521558 ], [ 1393591.00338595919311, 5859314.794959847815335 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E135", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1214.800048828125, "elevtn_dn": 1191.0999755859375, "invlev_up": 1212.300048828125, "invlev_dn": 1188.5999755859375, "manhole_up": "manhole_155_generated", "manhole_dn": "manhole_156_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393591.00338595919311, 5859314.794959847815335 ], [ 1393633.153639519121498, 5859288.066565420478582 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E136", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1191.0999755859375, "elevtn_dn": 1191.0999755859375, "invlev_up": 1188.5999755859375, "invlev_dn": 1188.5999755859375, "manhole_up": "manhole_156_generated", "manhole_dn": "manhole_157_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393633.153639519121498, 5859288.066565420478582 ], [ 1393673.123904188396409, 5859258.097712650895119 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E137", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1191.0999755859375, "elevtn_dn": 1144.300048828125, "invlev_up": 1188.5999755859375, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_157_generated", "manhole_dn": "manhole_158_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393673.123904188396409, 5859258.097712650895119 ], [ 1393720.523227575467899, 5859244.838272913359106 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E138", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1144.300048828125, "invlev_up": 1141.800048828125, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_158_generated", "manhole_dn": "manhole_159_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393720.523227575467899, 5859244.838272913359106 ], [ 1393765.710014625452459, 5859224.569284616038203 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E139", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1144.300048828125, "invlev_up": 1141.800048828125, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_159_generated", "manhole_dn": "manhole_160_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393765.710014625452459, 5859224.569284616038203 ], [ 1393806.409210936399177, 5859195.609256223775446 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E140", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1112.5, "invlev_up": 1141.800048828125, "invlev_dn": 1110.0, "manhole_up": "manhole_160_generated", "manhole_dn": "manhole_161_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393806.409210936399177, 5859195.609256223775446 ], [ 1393846.866742686368525, 5859166.301538489758968 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1045", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 968.29998779296875, "invlev_up": 965.79998779296875, "invlev_dn": 965.79998779296875, "manhole_up": "manhole_162_generated", "manhole_dn": "manhole_163_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388521.257592596346512, 5855362.027613477781415 ], [ 1388472.030306826578453, 5855370.543775821104646 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1046", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 968.29998779296875, "invlev_up": 965.79998779296875, "invlev_dn": 965.79998779296875, "manhole_up": "manhole_163_generated", "manhole_dn": "manhole_164_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388472.030306826578453, 5855370.543775821104646 ], [ 1388439.000347282737494, 5855407.802592809312046 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1047", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 964.5, "invlev_up": 965.79998779296875, "invlev_dn": 962.0, "manhole_up": "manhole_164_generated", "manhole_dn": "manhole_165_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388439.000347282737494, 5855407.802592809312046 ], [ 1388400.196091859601438, 5855436.014134516008198 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1048", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 964.5, "invlev_up": 962.0, "invlev_dn": 962.0, "manhole_up": "manhole_165_generated", "manhole_dn": "manhole_166_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388400.196091859601438, 5855436.014134516008198 ], [ 1388351.33823574683629, 5855446.634319253265858 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1049", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 981.9000244140625, "invlev_up": 962.0, "invlev_dn": 979.4000244140625, "manhole_up": "manhole_166_generated", "manhole_dn": "manhole_167_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388351.33823574683629, 5855446.634319253265858 ], [ 1388301.961881892289966, 5855453.847477887757123 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1050", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 981.9000244140625, "elevtn_dn": 981.9000244140625, "invlev_up": 979.4000244140625, "invlev_dn": 979.4000244140625, "manhole_up": "manhole_167_generated", "manhole_dn": "manhole_168_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388301.961881892289966, 5855453.847477887757123 ], [ 1388252.297577269142494, 5855451.260453455150127 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1051", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 981.9000244140625, "elevtn_dn": 973.70001220703125, "invlev_up": 979.4000244140625, "invlev_dn": 971.20001220703125, "manhole_up": "manhole_168_generated", "manhole_dn": "manhole_169_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388252.297577269142494, 5855451.260453455150127 ], [ 1388202.479659734526649, 5855455.508814659900963 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1052", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 973.70001220703125, "elevtn_dn": 961.70001220703125, "invlev_up": 971.20001220703125, "invlev_dn": 959.20001220703125, "manhole_up": "manhole_169_generated", "manhole_dn": "manhole_170_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388202.479659734526649, 5855455.508814659900963 ], [ 1388152.683455461403355, 5855460.015516467392445 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1053", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 961.70001220703125, "elevtn_dn": 961.70001220703125, "invlev_up": 959.20001220703125, "invlev_dn": 959.20001220703125, "manhole_up": "manhole_170_generated", "manhole_dn": "manhole_171_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388152.683455461403355, 5855460.015516467392445 ], [ 1388104.622611842118204, 5855473.253733876161277 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1054", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 961.70001220703125, "elevtn_dn": 945.79998779296875, "invlev_up": 959.20001220703125, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_171_generated", "manhole_dn": "manhole_172_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388104.622611842118204, 5855473.253733876161277 ], [ 1388057.00563437351957, 5855488.445189393125474 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1055", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 945.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_172_generated", "manhole_dn": "manhole_173_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388057.00563437351957, 5855488.445189393125474 ], [ 1388011.292356542311609, 5855508.700276436284184 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1056", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 945.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_173_generated", "manhole_dn": "manhole_174_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388011.292356542311609, 5855508.700276436284184 ], [ 1387969.221702651120722, 5855535.246164590120316 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1057", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 930.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 928.29998779296875, "manhole_up": "manhole_174_generated", "manhole_dn": "manhole_175_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.221702651120722, 5855535.246164590120316 ], [ 1387935.863196024205536, 5855572.491061648353934 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1058", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 930.79998779296875, "elevtn_dn": 957.10003662109375, "invlev_up": 928.29998779296875, "invlev_dn": 954.60003662109375, "manhole_up": "manhole_175_generated", "manhole_dn": "manhole_176_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387935.863196024205536, 5855572.491061648353934 ], [ 1387904.610231971368194, 5855611.432584651745856 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1059", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.10003662109375, "elevtn_dn": 947.4000244140625, "invlev_up": 954.60003662109375, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_176_generated", "manhole_dn": "manhole_177_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387904.610231971368194, 5855611.432584651745856 ], [ 1387869.335365027422085, 5855646.852918352000415 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1060", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 947.4000244140625, "invlev_up": 944.9000244140625, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_177_generated", "manhole_dn": "manhole_178_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387869.335365027422085, 5855646.852918352000415 ], [ 1387831.783288773847744, 5855679.735664095729589 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1061", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 947.4000244140625, "invlev_up": 944.9000244140625, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_178_generated", "manhole_dn": "manhole_179_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387831.783288773847744, 5855679.735664095729589 ], [ 1387791.509416193468496, 5855708.923279576934874 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1062", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 933.29998779296875, "invlev_up": 944.9000244140625, "invlev_dn": 930.79998779296875, "manhole_up": "manhole_179_generated", "manhole_dn": "manhole_180_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387791.509416193468496, 5855708.923279576934874 ], [ 1387742.459816947113723, 5855717.213657722808421 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1063", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.29998779296875, "elevtn_dn": 933.29998779296875, "invlev_up": 930.79998779296875, "invlev_dn": 930.79998779296875, "manhole_up": "manhole_180_generated", "manhole_dn": "manhole_181_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387742.459816947113723, 5855717.213657722808421 ], [ 1387692.500367184402421, 5855718.495403698645532 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1064", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.29998779296875, "elevtn_dn": 911.10003662109375, "invlev_up": 930.79998779296875, "invlev_dn": 908.60003662109375, "manhole_up": "manhole_181_generated", "manhole_dn": "manhole_182_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387692.500367184402421, 5855718.495403698645532 ], [ 1387642.500798417022452, 5855718.61967874225229 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1065", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.10003662109375, "elevtn_dn": 887.70001220703125, "invlev_up": 908.60003662109375, "invlev_dn": 885.20001220703125, "manhole_up": "manhole_182_generated", "manhole_dn": "manhole_183_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387642.500798417022452, 5855718.61967874225229 ], [ 1387592.501229649642482, 5855718.743953784927726 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1066", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 887.70001220703125, "elevtn_dn": 887.70001220703125, "invlev_up": 885.20001220703125, "invlev_dn": 885.20001220703125, "manhole_up": "manhole_183_generated", "manhole_dn": "manhole_184_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387592.501229649642482, 5855718.743953784927726 ], [ 1387542.501660882262513, 5855718.868228827603161 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1067", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 887.70001220703125, "elevtn_dn": 902.9000244140625, "invlev_up": 885.20001220703125, "invlev_dn": 900.4000244140625, "manhole_up": "manhole_184_generated", "manhole_dn": "manhole_185_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387542.501660882262513, 5855718.868228827603161 ], [ 1387492.651409652316943, 5855720.815255363471806 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1068", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 902.9000244140625, "elevtn_dn": 902.9000244140625, "invlev_up": 900.4000244140625, "invlev_dn": 900.4000244140625, "manhole_up": "manhole_185_generated", "manhole_dn": "manhole_186_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387492.651409652316943, 5855720.815255363471806 ], [ 1387448.867236748570576, 5855742.752516686916351 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1069", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 902.9000244140625, "elevtn_dn": 886.20001220703125, "invlev_up": 900.4000244140625, "invlev_dn": 883.70001220703125, "manhole_up": "manhole_186_generated", "manhole_dn": "manhole_187_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387448.867236748570576, 5855742.752516686916351 ], [ 1387402.432745414320379, 5855761.091833713464439 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1070", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 886.20001220703125, "elevtn_dn": 886.20001220703125, "invlev_up": 883.70001220703125, "invlev_dn": 883.70001220703125, "manhole_up": "manhole_187_generated", "manhole_dn": "manhole_188_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387402.432745414320379, 5855761.091833713464439 ], [ 1387355.687973388005048, 5855778.837216476909816 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1071", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 886.20001220703125, "elevtn_dn": 879.4000244140625, "invlev_up": 883.70001220703125, "invlev_dn": 876.9000244140625, "manhole_up": "manhole_188_generated", "manhole_dn": "manhole_189_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387355.687973388005048, 5855778.837216476909816 ], [ 1387308.943201361689717, 5855796.582599240355194 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1072", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 879.4000244140625, "elevtn_dn": 879.4000244140625, "invlev_up": 876.9000244140625, "invlev_dn": 876.9000244140625, "manhole_up": "manhole_189_generated", "manhole_dn": "manhole_190_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387308.943201361689717, 5855796.582599240355194 ], [ 1387262.861613623332232, 5855815.656713440082967 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1073", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 879.4000244140625, "elevtn_dn": 873.29998779296875, "invlev_up": 876.9000244140625, "invlev_dn": 870.79998779296875, "manhole_up": "manhole_190_generated", "manhole_dn": "manhole_191_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387262.861613623332232, 5855815.656713440082967 ], [ 1387224.059019178850576, 5855846.996291697025299 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1074", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 873.29998779296875, "elevtn_dn": 938.9000244140625, "invlev_up": 870.79998779296875, "invlev_dn": 936.4000244140625, "manhole_up": "manhole_191_generated", "manhole_dn": "manhole_192_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387224.059019178850576, 5855846.996291697025299 ], [ 1387180.719124856637791, 5855870.194651792757213 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1075", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 938.9000244140625, "elevtn_dn": 932.79998779296875, "invlev_up": 936.4000244140625, "invlev_dn": 930.29998779296875, "manhole_up": "manhole_192_generated", "manhole_dn": "manhole_193_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387180.719124856637791, 5855870.194651792757213 ], [ 1387131.003996425773948, 5855874.064550469629467 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1076", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.79998779296875, "elevtn_dn": 932.79998779296875, "invlev_up": 930.29998779296875, "invlev_dn": 930.29998779296875, "manhole_up": "manhole_193_generated", "manhole_dn": "manhole_194_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387131.003996425773948, 5855874.064550469629467 ], [ 1387081.098878284916282, 5855871.158613862469792 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1077", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.79998779296875, "elevtn_dn": 916.79998779296875, "invlev_up": 930.29998779296875, "invlev_dn": 914.29998779296875, "manhole_up": "manhole_194_generated", "manhole_dn": "manhole_195_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387081.098878284916282, 5855871.158613862469792 ], [ 1387031.198060098802671, 5855868.015261265449226 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1078", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 916.79998779296875, "elevtn_dn": 916.79998779296875, "invlev_up": 914.29998779296875, "invlev_dn": 914.29998779296875, "manhole_up": "manhole_195_generated", "manhole_dn": "manhole_196_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387031.198060098802671, 5855868.015261265449226 ], [ 1386981.297241912456229, 5855864.871908667497337 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1079", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 916.79998779296875, "elevtn_dn": 891.79998779296875, "invlev_up": 914.29998779296875, "invlev_dn": 889.29998779296875, "manhole_up": "manhole_196_generated", "manhole_dn": "manhole_197_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386981.297241912456229, 5855864.871908667497337 ], [ 1386931.47147326474078, 5855860.718019699677825 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1080", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.79998779296875, "elevtn_dn": 891.79998779296875, "invlev_up": 889.29998779296875, "invlev_dn": 889.29998779296875, "manhole_up": "manhole_197_generated", "manhole_dn": "manhole_198_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386931.47147326474078, 5855860.718019699677825 ], [ 1386881.600663758814335, 5855857.577047945931554 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1081", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.79998779296875, "elevtn_dn": 857.10003662109375, "invlev_up": 889.29998779296875, "invlev_dn": 854.60003662109375, "manhole_up": "manhole_198_generated", "manhole_dn": "manhole_199_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386881.600663758814335, 5855857.577047945931554 ], [ 1386832.545593914575875, 5855864.100992278195918 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1082", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 857.10003662109375, "elevtn_dn": 857.10003662109375, "invlev_up": 854.60003662109375, "invlev_dn": 854.60003662109375, "manhole_up": "manhole_199_generated", "manhole_dn": "manhole_200_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386832.545593914575875, 5855864.100992278195918 ], [ 1386787.06764860637486, 5855884.403254445642233 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1083", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 857.10003662109375, "elevtn_dn": 821.29998779296875, "invlev_up": 854.60003662109375, "invlev_dn": 818.79998779296875, "manhole_up": "manhole_200_generated", "manhole_dn": "manhole_201_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386787.06764860637486, 5855884.403254445642233 ], [ 1386748.278358669718727, 5855915.544586268253624 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1084", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 821.29998779296875, "elevtn_dn": 821.29998779296875, "invlev_up": 818.79998779296875, "invlev_dn": 818.79998779296875, "manhole_up": "manhole_201_generated", "manhole_dn": "manhole_202_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386748.278358669718727, 5855915.544586268253624 ], [ 1386721.155419877264649, 5855957.124278785660863 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1085", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 821.29998779296875, "elevtn_dn": 866.0, "invlev_up": 818.79998779296875, "invlev_dn": 863.5, "manhole_up": "manhole_202_generated", "manhole_dn": "manhole_203_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386721.155419877264649, 5855957.124278785660863 ], [ 1386707.750365849817172, 5856004.850832763127983 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1086", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 866.0, "invlev_up": 863.5, "invlev_dn": 863.5, "manhole_up": "manhole_203_generated", "manhole_dn": "manhole_204_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386707.750365849817172, 5856004.850832763127983 ], [ 1386699.832475832896307, 5856054.133603978902102 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1087", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 866.0, "invlev_up": 863.5, "invlev_dn": 863.5, "manhole_up": "manhole_204_generated", "manhole_dn": "manhole_205_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386699.832475832896307, 5856054.133603978902102 ], [ 1386697.095561265014112, 5856103.986880083568394 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1088", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 884.79998779296875, "invlev_up": 863.5, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_205_generated", "manhole_dn": "manhole_206_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386697.095561265014112, 5856103.986880083568394 ], [ 1386699.401158998254687, 5856153.933416903018951 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1089", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 884.79998779296875, "invlev_up": 882.29998779296875, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_206_generated", "manhole_dn": "manhole_207_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386699.401158998254687, 5856153.933416903018951 ], [ 1386715.699191288091242, 5856201.197657831013203 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1090", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 884.79998779296875, "invlev_up": 882.29998779296875, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_207_generated", "manhole_dn": "manhole_208_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386715.699191288091242, 5856201.197657831013203 ], [ 1386741.121203816728666, 5856244.100116757676005 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1091", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 915.9000244140625, "invlev_up": 882.29998779296875, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_208_generated", "manhole_dn": "manhole_209_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386741.121203816728666, 5856244.100116757676005 ], [ 1386774.051378605188802, 5856281.577651324681938 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1092", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_209_generated", "manhole_dn": "manhole_210_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386774.051378605188802, 5856281.577651324681938 ], [ 1386811.583791718119755, 5856314.587093180976808 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1093", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_210_generated", "manhole_dn": "manhole_211_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386811.583791718119755, 5856314.587093180976808 ], [ 1386839.378956499742344, 5856356.087350118905306 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1094", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_211_generated", "manhole_dn": "manhole_212_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386839.378956499742344, 5856356.087350118905306 ], [ 1386855.653891535941511, 5856403.364181768149137 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1095", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_212_generated", "manhole_dn": "manhole_213_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386855.653891535941511, 5856403.364181768149137 ], [ 1386875.714553950354457, 5856449.116945925168693 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1096", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_213_generated", "manhole_dn": "manhole_214_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386875.714553950354457, 5856449.116945925168693 ], [ 1386912.179653002182022, 5856482.939191372133791 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1097", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_214_generated", "manhole_dn": "manhole_215_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386912.179653002182022, 5856482.939191372133791 ], [ 1386944.191176384687424, 5856520.270725904032588 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1098", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 911.79998779296875, "invlev_up": 907.4000244140625, "invlev_dn": 909.29998779296875, "manhole_up": "manhole_215_generated", "manhole_dn": "manhole_216_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386944.191176384687424, 5856520.270725904032588 ], [ 1386964.188513180473819, 5856566.025075756013393 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1099", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.79998779296875, "elevtn_dn": 911.79998779296875, "invlev_up": 909.29998779296875, "invlev_dn": 909.29998779296875, "manhole_up": "manhole_216_generated", "manhole_dn": "manhole_217_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386964.188513180473819, 5856566.025075756013393 ], [ 1386998.825215350603685, 5856599.261941562406719 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1100", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.79998779296875, "elevtn_dn": 932.0, "invlev_up": 909.29998779296875, "invlev_dn": 929.5, "manhole_up": "manhole_217_generated", "manhole_dn": "manhole_218_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386998.825215350603685, 5856599.261941562406719 ], [ 1387044.828526843106374, 5856618.849377661012113 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1101", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 932.0, "invlev_up": 929.5, "invlev_dn": 929.5, "manhole_up": "manhole_218_generated", "manhole_dn": "manhole_219_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387044.828526843106374, 5856618.849377661012113 ], [ 1387090.831838335609064, 5856638.43681376054883 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1102", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 949.9000244140625, "invlev_up": 929.5, "invlev_dn": 947.4000244140625, "manhole_up": "manhole_219_generated", "manhole_dn": "manhole_220_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387090.831838335609064, 5856638.43681376054883 ], [ 1387136.835149827878922, 5856658.024249859154224 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1103", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 949.9000244140625, "elevtn_dn": 924.4000244140625, "invlev_up": 947.4000244140625, "invlev_dn": 921.9000244140625, "manhole_up": "manhole_220_generated", "manhole_dn": "manhole_221_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387136.835149827878922, 5856658.024249859154224 ], [ 1387178.671980312326923, 5856685.128790453076363 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1104", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 924.4000244140625, "elevtn_dn": 924.4000244140625, "invlev_up": 921.9000244140625, "invlev_dn": 921.9000244140625, "manhole_up": "manhole_221_generated", "manhole_dn": "manhole_222_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387178.671980312326923, 5856685.128790453076363 ], [ 1387217.700535611249506, 5856716.320352808572352 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1105", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 924.4000244140625, "elevtn_dn": 940.0, "invlev_up": 921.9000244140625, "invlev_dn": 937.5, "manhole_up": "manhole_222_generated", "manhole_dn": "manhole_223_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387217.700535611249506, 5856716.320352808572352 ], [ 1387252.016686553368345, 5856752.649443434551358 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1106", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.0, "elevtn_dn": 940.0, "invlev_up": 937.5, "invlev_dn": 937.5, "manhole_up": "manhole_223_generated", "manhole_dn": "manhole_224_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387252.016686553368345, 5856752.649443434551358 ], [ 1387284.798919493798167, 5856790.190159549936652 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1107", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.0, "elevtn_dn": 894.29998779296875, "invlev_up": 937.5, "invlev_dn": 891.79998779296875, "manhole_up": "manhole_224_generated", "manhole_dn": "manhole_225_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387284.798919493798167, 5856790.190159549936652 ], [ 1387273.050185391213745, 5856831.931571422144771 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1108", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 894.29998779296875, "elevtn_dn": 891.5, "invlev_up": 891.79998779296875, "invlev_dn": 889.0, "manhole_up": "manhole_225_generated", "manhole_dn": "manhole_226_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387273.050185391213745, 5856831.931571422144771 ], [ 1387226.106990416301414, 5856849.145192969590425 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1109", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.5, "elevtn_dn": 891.5, "invlev_up": 889.0, "invlev_dn": 889.0, "manhole_up": "manhole_226_generated", "manhole_dn": "manhole_227_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387226.106990416301414, 5856849.145192969590425 ], [ 1387179.163795441389084, 5856866.358814516104758 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1110", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.5, "elevtn_dn": 881.0, "invlev_up": 889.0, "invlev_dn": 878.5, "manhole_up": "manhole_227_generated", "manhole_dn": "manhole_228_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387179.163795441389084, 5856866.358814516104758 ], [ 1387132.220600466709584, 5856883.572436063550413 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1111", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_228_generated", "manhole_dn": "manhole_229_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387132.220600466709584, 5856883.572436063550413 ], [ 1387091.513159692520276, 5856911.129930667579174 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1112", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_229_generated", "manhole_dn": "manhole_230_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387091.513159692520276, 5856911.129930667579174 ], [ 1387071.007118243258446, 5856956.15559543017298 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1113", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_230_generated", "manhole_dn": "manhole_231_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387071.007118243258446, 5856956.15559543017298 ], [ 1387043.749112035380676, 5856996.689189162105322 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1114", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 856.5, "invlev_up": 878.5, "invlev_dn": 854.0, "manhole_up": "manhole_231_generated", "manhole_dn": "manhole_232_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387043.749112035380676, 5856996.689189162105322 ], [ 1387004.639443967491388, 5857027.840532388538122 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1115", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_232_generated", "manhole_dn": "manhole_233_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387004.639443967491388, 5857027.840532388538122 ], [ 1386965.529775899834931, 5857058.991875615902245 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1116", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_233_generated", "manhole_dn": "manhole_234_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386965.529775899834931, 5857058.991875615902245 ], [ 1386926.702535050921142, 5857090.440239730291069 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1117", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_234_generated", "manhole_dn": "manhole_235_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386926.702535050921142, 5857090.440239730291069 ], [ 1386899.700979894958436, 5857131.871505072340369 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1118", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_235_generated", "manhole_dn": "manhole_236_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386899.700979894958436, 5857131.871505072340369 ], [ 1386903.6263940166682, 5857181.005935152061284 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1119", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 867.29998779296875, "invlev_up": 854.0, "invlev_dn": 864.79998779296875, "manhole_up": "manhole_236_generated", "manhole_dn": "manhole_237_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386903.6263940166682, 5857181.005935152061284 ], [ 1386920.841401966754347, 5857227.85734468139708 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1120", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 867.29998779296875, "elevtn_dn": 867.29998779296875, "invlev_up": 864.79998779296875, "invlev_dn": 864.79998779296875, "manhole_up": "manhole_237_generated", "manhole_dn": "manhole_238_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386920.841401966754347, 5857227.85734468139708 ], [ 1386940.647245415020734, 5857273.767048302106559 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1121", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 867.29998779296875, "elevtn_dn": 879.0, "invlev_up": 864.79998779296875, "invlev_dn": 876.5, "manhole_up": "manhole_238_generated", "manhole_dn": "manhole_239_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386940.647245415020734, 5857273.767048302106559 ], [ 1386960.453088863519952, 5857319.676751921884716 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1122", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 879.0, "elevtn_dn": 884.5, "invlev_up": 876.5, "invlev_dn": 882.0, "manhole_up": "manhole_239_generated", "manhole_dn": "manhole_240_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386960.453088863519952, 5857319.676751921884716 ], [ 1386980.258932311786339, 5857365.586455542594194 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1123", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 884.5, "invlev_up": 882.0, "invlev_dn": 882.0, "manhole_up": "manhole_240_generated", "manhole_dn": "manhole_241_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386980.258932311786339, 5857365.586455542594194 ], [ 1387000.064775760285556, 5857411.496159162372351 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1124", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 884.5, "invlev_up": 882.0, "invlev_dn": 882.0, "manhole_up": "manhole_241_generated", "manhole_dn": "manhole_242_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387000.064775760285556, 5857411.496159162372351 ], [ 1387007.528902114601806, 5857459.537025099620223 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1125", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 893.20001220703125, "invlev_up": 882.0, "invlev_dn": 890.70001220703125, "manhole_up": "manhole_242_generated", "manhole_dn": "manhole_243_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387007.528902114601806, 5857459.537025099620223 ], [ 1386963.21676475298591, 5857476.629049208015203 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1126", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 893.20001220703125, "elevtn_dn": 893.70001220703125, "invlev_up": 890.70001220703125, "invlev_dn": 891.20001220703125, "manhole_up": "manhole_243_generated", "manhole_dn": "manhole_244_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386963.21676475298591, 5857476.629049208015203 ], [ 1386913.783934087026864, 5857484.135433598421514 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1127", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 893.70001220703125, "elevtn_dn": 893.70001220703125, "invlev_up": 891.20001220703125, "invlev_dn": 891.20001220703125, "manhole_up": "manhole_244_generated", "manhole_dn": "manhole_245_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386913.783934087026864, 5857484.135433598421514 ], [ 1386870.539328352315351, 5857507.055611960589886 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1128", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 893.70001220703125, "elevtn_dn": 889.70001220703125, "invlev_up": 891.20001220703125, "invlev_dn": 887.20001220703125, "manhole_up": "manhole_245_generated", "manhole_dn": "manhole_246_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386870.539328352315351, 5857507.055611960589886 ], [ 1386832.820274166297168, 5857539.877026806585491 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1129", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.70001220703125, "elevtn_dn": 889.70001220703125, "invlev_up": 887.20001220703125, "invlev_dn": 887.20001220703125, "manhole_up": "manhole_246_generated", "manhole_dn": "manhole_247_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386832.820274166297168, 5857539.877026806585491 ], [ 1386795.101531907683238, 5857572.698800123296678 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1130", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.70001220703125, "elevtn_dn": 872.4000244140625, "invlev_up": 887.20001220703125, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_247_generated", "manhole_dn": "manhole_248_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386795.101531907683238, 5857572.698800123296678 ], [ 1386758.257366374600679, 5857606.496797049418092 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1131", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 872.4000244140625, "invlev_up": 869.9000244140625, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_248_generated", "manhole_dn": "manhole_249_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386758.257366374600679, 5857606.496797049418092 ], [ 1386721.502390186069533, 5857640.394349270500243 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1132", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 872.4000244140625, "invlev_up": 869.9000244140625, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_249_generated", "manhole_dn": "manhole_250_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386721.502390186069533, 5857640.394349270500243 ], [ 1386691.639095245627686, 5857680.292891399934888 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1133", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 860.70001220703125, "invlev_up": 869.9000244140625, "invlev_dn": 858.20001220703125, "manhole_up": "manhole_250_generated", "manhole_dn": "manhole_251_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386691.639095245627686, 5857680.292891399934888 ], [ 1386663.127201205352321, 5857721.366519738920033 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1134", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 860.70001220703125, "elevtn_dn": 864.10003662109375, "invlev_up": 858.20001220703125, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_251_generated", "manhole_dn": "manhole_252_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386663.127201205352321, 5857721.366519738920033 ], [ 1386634.70784462057054, 5857762.504245642572641 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1135", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 864.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_252_generated", "manhole_dn": "manhole_253_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386634.70784462057054, 5857762.504245642572641 ], [ 1386606.28848803602159, 5857803.64197154622525 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1136", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 864.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_253_generated", "manhole_dn": "manhole_254_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386606.28848803602159, 5857803.64197154622525 ], [ 1386577.851668093586341, 5857844.766917760483921 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1137", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 836.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 833.60003662109375, "manhole_up": "manhole_254_generated", "manhole_dn": "manhole_255_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386577.851668093586341, 5857844.766917760483921 ], [ 1386559.479123871540651, 5857890.340473555959761 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1138", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 836.10003662109375, "elevtn_dn": 836.10003662109375, "invlev_up": 833.60003662109375, "invlev_dn": 833.60003662109375, "manhole_up": "manhole_255_generated", "manhole_dn": "manhole_256_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386559.479123871540651, 5857890.340473555959761 ], [ 1386576.858566463226452, 5857935.633445805869997 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1139", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 836.10003662109375, "elevtn_dn": 854.9000244140625, "invlev_up": 833.60003662109375, "invlev_dn": 852.4000244140625, "manhole_up": "manhole_256_generated", "manhole_dn": "manhole_257_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386576.858566463226452, 5857935.633445805869997 ], [ 1386619.073707325849682, 5857961.189545376226306 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1140", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.9000244140625, "elevtn_dn": 854.9000244140625, "invlev_up": 852.4000244140625, "invlev_dn": 852.4000244140625, "manhole_up": "manhole_257_generated", "manhole_dn": "manhole_258_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386619.073707325849682, 5857961.189545376226306 ], [ 1386664.860782509436831, 5857981.27706332411617 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1141", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.9000244140625, "elevtn_dn": 871.60003662109375, "invlev_up": 852.4000244140625, "invlev_dn": 869.10003662109375, "manhole_up": "manhole_258_generated", "manhole_dn": "manhole_259_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386664.860782509436831, 5857981.27706332411617 ], [ 1386710.721602912992239, 5858001.195835201069713 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1142", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 871.60003662109375, "elevtn_dn": 865.10003662109375, "invlev_up": 869.10003662109375, "invlev_dn": 862.60003662109375, "manhole_up": "manhole_259_generated", "manhole_dn": "manhole_260_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386710.721602912992239, 5858001.195835201069713 ], [ 1386756.582423316547647, 5858021.114607078954577 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1143", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 865.10003662109375, "elevtn_dn": 864.70001220703125, "invlev_up": 862.60003662109375, "invlev_dn": 862.20001220703125, "manhole_up": "manhole_260_generated", "manhole_dn": "manhole_261_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386756.582423316547647, 5858021.114607078954577 ], [ 1386802.443243720103055, 5858041.033378956839442 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1144", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.70001220703125, "elevtn_dn": 864.70001220703125, "invlev_up": 862.20001220703125, "invlev_dn": 862.20001220703125, "manhole_up": "manhole_261_generated", "manhole_dn": "manhole_262_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386802.443243720103055, 5858041.033378956839442 ], [ 1386848.304064123658463, 5858060.952150834724307 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1145", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.70001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 862.20001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_262_generated", "manhole_dn": "manhole_263_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386848.304064123658463, 5858060.952150834724307 ], [ 1386892.843548113014549, 5858083.471454747952521 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1146", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_263_generated", "manhole_dn": "manhole_264_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386892.843548113014549, 5858083.471454747952521 ], [ 1386931.443847785238177, 5858115.251781782135367 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1147", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 853.60003662109375, "invlev_up": 856.70001220703125, "invlev_dn": 851.10003662109375, "manhole_up": "manhole_264_generated", "manhole_dn": "manhole_265_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386931.443847785238177, 5858115.251781782135367 ], [ 1386970.044147457228974, 5858147.032108817249537 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1148", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 853.60003662109375, "elevtn_dn": 853.60003662109375, "invlev_up": 851.10003662109375, "invlev_dn": 851.10003662109375, "manhole_up": "manhole_265_generated", "manhole_dn": "manhole_266_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386970.044147457228974, 5858147.032108817249537 ], [ 1387008.644447129452601, 5858178.812435851432383 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1149", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 853.60003662109375, "elevtn_dn": 842.4000244140625, "invlev_up": 851.10003662109375, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_266_generated", "manhole_dn": "manhole_267_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387008.644447129452601, 5858178.812435851432383 ], [ 1387047.244746801443398, 5858210.592762886546552 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1150", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 842.4000244140625, "invlev_up": 839.9000244140625, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_267_generated", "manhole_dn": "manhole_268_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387047.244746801443398, 5858210.592762886546552 ], [ 1387085.845046473667026, 5858242.373089920729399 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1151", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 842.4000244140625, "invlev_up": 839.9000244140625, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_268_generated", "manhole_dn": "manhole_269_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387085.845046473667026, 5858242.373089920729399 ], [ 1387124.445346145657822, 5858274.153416955843568 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1152", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 827.60003662109375, "invlev_up": 839.9000244140625, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_269_generated", "manhole_dn": "manhole_270_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387124.445346145657822, 5858274.153416955843568 ], [ 1387163.04564581788145, 5858305.933743990026414 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1153", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_270_generated", "manhole_dn": "manhole_271_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387163.04564581788145, 5858305.933743990026414 ], [ 1387201.829349192325026, 5858337.489215047098696 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1154", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 837.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 835.10003662109375, "manhole_up": "manhole_271_generated", "manhole_dn": "manhole_272_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387201.829349192325026, 5858337.489215047098696 ], [ 1387246.200623227981851, 5858359.687651782296598 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1155", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 837.60003662109375, "elevtn_dn": 837.60003662109375, "invlev_up": 835.10003662109375, "invlev_dn": 835.10003662109375, "manhole_up": "manhole_272_generated", "manhole_dn": "manhole_273_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387246.200623227981851, 5858359.687651782296598 ], [ 1387293.201938283629715, 5858376.741938757710159 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1156", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 837.60003662109375, "elevtn_dn": 843.79998779296875, "invlev_up": 835.10003662109375, "invlev_dn": 841.29998779296875, "manhole_up": "manhole_273_generated", "manhole_dn": "manhole_274_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387293.201938283629715, 5858376.741938757710159 ], [ 1387334.200528149493039, 5858401.732468435540795 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1157", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 843.79998779296875, "elevtn_dn": 822.60003662109375, "invlev_up": 841.29998779296875, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_274_generated", "manhole_dn": "manhole_275_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387334.200528149493039, 5858401.732468435540795 ], [ 1387307.843875054037198, 5858437.110805934295058 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1158", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 822.60003662109375, "invlev_up": 820.10003662109375, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_275_generated", "manhole_dn": "manhole_276_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387307.843875054037198, 5858437.110805934295058 ], [ 1387260.279569417703897, 5858425.045736069791019 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1159", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 820.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_276_generated", "manhole_dn": "manhole_277_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387260.279569417703897, 5858425.045736069791019 ], [ 1387211.448235018178821, 5858414.300554806366563 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1160", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_277_generated", "manhole_dn": "manhole_278_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387211.448235018178821, 5858414.300554806366563 ], [ 1387162.612191663123667, 5858403.576134512200952 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1161", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 822.29998779296875, "invlev_up": 825.10003662109375, "invlev_dn": 819.79998779296875, "manhole_up": "manhole_278_generated", "manhole_dn": "manhole_279_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387162.612191663123667, 5858403.576134512200952 ], [ 1387113.700150535441935, 5858393.210482948459685 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1162", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.29998779296875, "elevtn_dn": 822.29998779296875, "invlev_up": 819.79998779296875, "invlev_dn": 819.79998779296875, "manhole_up": "manhole_279_generated", "manhole_dn": "manhole_280_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387113.700150535441935, 5858393.210482948459685 ], [ 1387064.993171223672107, 5858381.975642333738506 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1163", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.29998779296875, "elevtn_dn": 827.79998779296875, "invlev_up": 819.79998779296875, "invlev_dn": 825.29998779296875, "manhole_up": "manhole_280_generated", "manhole_dn": "manhole_281_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387064.993171223672107, 5858381.975642333738506 ], [ 1387015.796386598376557, 5858376.342007979750633 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1164", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.79998779296875, "elevtn_dn": 827.79998779296875, "invlev_up": 825.29998779296875, "invlev_dn": 825.29998779296875, "manhole_up": "manhole_281_generated", "manhole_dn": "manhole_282_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387015.796386598376557, 5858376.342007979750633 ], [ 1386966.208506174152717, 5858382.746259398758411 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1165", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.79998779296875, "elevtn_dn": 833.9000244140625, "invlev_up": 825.29998779296875, "invlev_dn": 831.4000244140625, "manhole_up": "manhole_282_generated", "manhole_dn": "manhole_283_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386966.208506174152717, 5858382.746259398758411 ], [ 1386916.676812386140227, 5858389.559525708667934 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1166", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 833.9000244140625, "elevtn_dn": 833.9000244140625, "invlev_up": 831.4000244140625, "invlev_dn": 831.4000244140625, "manhole_up": "manhole_283_generated", "manhole_dn": "manhole_284_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386916.676812386140227, 5858389.559525708667934 ], [ 1386867.198860567295924, 5858396.764010772109032 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1167", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 833.9000244140625, "elevtn_dn": 833.20001220703125, "invlev_up": 831.4000244140625, "invlev_dn": 830.70001220703125, "manhole_up": "manhole_284_generated", "manhole_dn": "manhole_285_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386867.198860567295924, 5858396.764010772109032 ], [ 1386820.816385147860274, 5858411.854353901930153 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1168", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 833.20001220703125, "elevtn_dn": 809.60003662109375, "invlev_up": 830.70001220703125, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_285_generated", "manhole_dn": "manhole_286_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386820.816385147860274, 5858411.854353901930153 ], [ 1386841.361234750133008, 5858445.514383808709681 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1169", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 809.79998779296875, "invlev_up": 807.10003662109375, "invlev_dn": 807.29998779296875, "manhole_up": "manhole_286_generated", "manhole_dn": "manhole_287_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386841.361234750133008, 5858445.514383808709681 ], [ 1386890.796275103231892, 5858452.915634987875819 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1170", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.79998779296875, "elevtn_dn": 809.79998779296875, "invlev_up": 807.29998779296875, "invlev_dn": 807.29998779296875, "manhole_up": "manhole_287_generated", "manhole_dn": "manhole_288_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386890.796275103231892, 5858452.915634987875819 ], [ 1386940.277140651131049, 5858460.100081093609333 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1171", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.79998779296875, "elevtn_dn": 805.4000244140625, "invlev_up": 807.29998779296875, "invlev_dn": 802.9000244140625, "manhole_up": "manhole_288_generated", "manhole_dn": "manhole_289_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386940.277140651131049, 5858460.100081093609333 ], [ 1386989.847997799050063, 5858466.483407464809716 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1172", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.4000244140625, "elevtn_dn": 805.4000244140625, "invlev_up": 802.9000244140625, "invlev_dn": 802.9000244140625, "manhole_up": "manhole_289_generated", "manhole_dn": "manhole_290_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386989.847997799050063, 5858466.483407464809716 ], [ 1387039.689648573985323, 5858470.45608530472964 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1173", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.4000244140625, "elevtn_dn": 804.60003662109375, "invlev_up": 802.9000244140625, "invlev_dn": 802.10003662109375, "manhole_up": "manhole_290_generated", "manhole_dn": "manhole_291_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387039.689648573985323, 5858470.45608530472964 ], [ 1387088.843806148739532, 5858479.424946941435337 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1174", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.60003662109375, "elevtn_dn": 809.9000244140625, "invlev_up": 802.10003662109375, "invlev_dn": 807.4000244140625, "manhole_up": "manhole_291_generated", "manhole_dn": "manhole_292_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387088.843806148739532, 5858479.424946941435337 ], [ 1387137.90604472765699, 5858489.061806742101908 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1175", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.9000244140625, "elevtn_dn": 809.9000244140625, "invlev_up": 807.4000244140625, "invlev_dn": 807.4000244140625, "manhole_up": "manhole_292_generated", "manhole_dn": "manhole_293_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387137.90604472765699, 5858489.061806742101908 ], [ 1387186.336529975291342, 5858500.87968063633889 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1176", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.9000244140625, "elevtn_dn": 822.60003662109375, "invlev_up": 807.4000244140625, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_293_generated", "manhole_dn": "manhole_294_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387186.336529975291342, 5858500.87968063633889 ], [ 1387231.661050535272807, 5858521.423059928230941 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1177", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 787.70001220703125, "invlev_up": 820.10003662109375, "invlev_dn": 785.20001220703125, "manhole_up": "manhole_294_generated", "manhole_dn": "manhole_295_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387231.661050535272807, 5858521.423059928230941 ], [ 1387268.120024613803253, 5858555.03504909388721 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1178", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.70001220703125, "elevtn_dn": 787.70001220703125, "invlev_up": 785.20001220703125, "invlev_dn": 785.20001220703125, "manhole_up": "manhole_295_generated", "manhole_dn": "manhole_296_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387268.120024613803253, 5858555.03504909388721 ], [ 1387300.917169471969828, 5858592.775208213366568 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1179", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.70001220703125, "elevtn_dn": 797.10003662109375, "invlev_up": 785.20001220703125, "invlev_dn": 794.60003662109375, "manhole_up": "manhole_296_generated", "manhole_dn": "manhole_297_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387300.917169471969828, 5858592.775208213366568 ], [ 1387340.521646688459441, 5858622.315198052674532 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1180", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 797.10003662109375, "elevtn_dn": 797.10003662109375, "invlev_up": 794.60003662109375, "invlev_dn": 794.60003662109375, "manhole_up": "manhole_297_generated", "manhole_dn": "manhole_298_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387340.521646688459441, 5858622.315198052674532 ], [ 1387387.476920192595571, 5858639.495844470337033 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1181", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 797.10003662109375, "elevtn_dn": 806.10003662109375, "invlev_up": 794.60003662109375, "invlev_dn": 803.60003662109375, "manhole_up": "manhole_298_generated", "manhole_dn": "manhole_299_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387387.476920192595571, 5858639.495844470337033 ], [ 1387436.116963447071612, 5858650.82861250359565 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1182", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.10003662109375, "elevtn_dn": 806.10003662109375, "invlev_up": 803.60003662109375, "invlev_dn": 803.60003662109375, "manhole_up": "manhole_299_generated", "manhole_dn": "manhole_300_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387436.116963447071612, 5858650.82861250359565 ], [ 1387485.194103535497561, 5858660.261457678861916 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1183", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.10003662109375, "elevtn_dn": 807.70001220703125, "invlev_up": 803.60003662109375, "invlev_dn": 805.20001220703125, "manhole_up": "manhole_300_generated", "manhole_dn": "manhole_301_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387485.194103535497561, 5858660.261457678861916 ], [ 1387533.804190448950976, 5858671.493853995576501 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1184", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.70001220703125, "elevtn_dn": 772.20001220703125, "invlev_up": 805.20001220703125, "invlev_dn": 769.70001220703125, "manhole_up": "manhole_301_generated", "manhole_dn": "manhole_302_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387533.804190448950976, 5858671.493853995576501 ], [ 1387580.2968336828053, 5858689.619015210308135 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1185", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.20001220703125, "elevtn_dn": 778.79998779296875, "invlev_up": 769.70001220703125, "invlev_dn": 776.29998779296875, "manhole_up": "manhole_302_generated", "manhole_dn": "manhole_303_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387580.2968336828053, 5858689.619015210308135 ], [ 1387628.455277157016098, 5858703.062848121859133 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1186", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.79998779296875, "elevtn_dn": 778.79998779296875, "invlev_up": 776.29998779296875, "invlev_dn": 776.29998779296875, "manhole_up": "manhole_303_generated", "manhole_dn": "manhole_304_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387628.455277157016098, 5858703.062848121859133 ], [ 1387677.211432087467983, 5858713.7862489502877 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1187", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.79998779296875, "elevtn_dn": 786.70001220703125, "invlev_up": 776.29998779296875, "invlev_dn": 784.20001220703125, "manhole_up": "manhole_304_generated", "manhole_dn": "manhole_305_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387677.211432087467983, 5858713.7862489502877 ], [ 1387726.995392211945727, 5858712.747126803733408 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1188", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.70001220703125, "elevtn_dn": 786.70001220703125, "invlev_up": 784.20001220703125, "invlev_dn": 784.20001220703125, "manhole_up": "manhole_305_generated", "manhole_dn": "manhole_306_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387726.995392211945727, 5858712.747126803733408 ], [ 1387773.343349169706926, 5858725.014477553777397 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1189", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.70001220703125, "elevtn_dn": 797.70001220703125, "invlev_up": 784.20001220703125, "invlev_dn": 795.20001220703125, "manhole_up": "manhole_306_generated", "manhole_dn": "manhole_307_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387773.343349169706926, 5858725.014477553777397 ], [ 1387806.363672176143155, 5858762.310494473204017 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1190", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 797.70001220703125, "elevtn_dn": 797.70001220703125, "invlev_up": 795.20001220703125, "invlev_dn": 795.20001220703125, "manhole_up": "manhole_307_generated", "manhole_dn": "manhole_308_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387806.363672176143155, 5858762.310494473204017 ], [ 1387799.717027904232964, 5858810.149600365199149 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1191", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 797.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 795.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_308_generated", "manhole_dn": "manhole_309_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387799.717027904232964, 5858810.149600365199149 ], [ 1387771.971139753237367, 5858850.86109375115484 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1192", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_309_generated", "manhole_dn": "manhole_310_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387771.971139753237367, 5858850.86109375115484 ], [ 1387723.07675126590766, 5858854.679317841306329 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1193", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_310_generated", "manhole_dn": "manhole_311_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387723.07675126590766, 5858854.679317841306329 ], [ 1387673.274138238513842, 5858850.996178055182099 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1194", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_311_generated", "manhole_dn": "manhole_312_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387673.274138238513842, 5858850.996178055182099 ], [ 1387624.170362570788711, 5858858.384703231044114 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1195", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_312_generated", "manhole_dn": "manhole_313_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387624.170362570788711, 5858858.384703231044114 ], [ 1387575.715393897145987, 5858857.046076283790171 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1196", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_313_generated", "manhole_dn": "manhole_314_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387575.715393897145987, 5858857.046076283790171 ], [ 1387529.438332577701658, 5858838.116818149574101 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1197", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_314_generated", "manhole_dn": "manhole_315_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387529.438332577701658, 5858838.116818149574101 ], [ 1387481.179235466290265, 5858825.222027675248682 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1198", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_315_generated", "manhole_dn": "manhole_316_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387481.179235466290265, 5858825.222027675248682 ], [ 1387432.215501294471323, 5858815.797906777821481 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1199", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 772.79998779296875, "invlev_up": 774.70001220703125, "invlev_dn": 770.29998779296875, "manhole_up": "manhole_316_generated", "manhole_dn": "manhole_317_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387432.215501294471323, 5858815.797906777821481 ], [ 1387382.431881646160036, 5858811.154251328669488 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1200", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.79998779296875, "elevtn_dn": 747.10003662109375, "invlev_up": 770.29998779296875, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_317_generated", "manhole_dn": "manhole_318_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387382.431881646160036, 5858811.154251328669488 ], [ 1387336.607072548242286, 5858824.075685098767281 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1201", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 747.10003662109375, "invlev_up": 744.60003662109375, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_318_generated", "manhole_dn": "manhole_319_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387336.607072548242286, 5858824.075685098767281 ], [ 1387327.458137275883928, 5858870.88596049696207 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1202", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 747.10003662109375, "invlev_up": 744.60003662109375, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_319_generated", "manhole_dn": "manhole_320_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387327.458137275883928, 5858870.88596049696207 ], [ 1387344.619252334116027, 5858917.848375800997019 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1203", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 773.70001220703125, "invlev_up": 744.60003662109375, "invlev_dn": 771.20001220703125, "manhole_up": "manhole_320_generated", "manhole_dn": "manhole_321_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387344.619252334116027, 5858917.848375800997019 ], [ 1387358.089983508689329, 5858965.710649829357862 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1204", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 773.70001220703125, "elevtn_dn": 773.70001220703125, "invlev_up": 771.20001220703125, "invlev_dn": 771.20001220703125, "manhole_up": "manhole_321_generated", "manhole_dn": "manhole_322_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387358.089983508689329, 5858965.710649829357862 ], [ 1387329.564612702699378, 5859003.583583393134177 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1205", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 773.70001220703125, "elevtn_dn": 774.29998779296875, "invlev_up": 771.20001220703125, "invlev_dn": 771.79998779296875, "manhole_up": "manhole_322_generated", "manhole_dn": "manhole_323_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387329.564612702699378, 5859003.583583393134177 ], [ 1387285.783744251355529, 5858993.703191691078246 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1206", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.29998779296875, "elevtn_dn": 774.29998779296875, "invlev_up": 771.79998779296875, "invlev_dn": 771.79998779296875, "manhole_up": "manhole_323_generated", "manhole_dn": "manhole_324_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387285.783744251355529, 5858993.703191691078246 ], [ 1387248.355973182013258, 5858961.31797497626394 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1207", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.29998779296875, "elevtn_dn": 769.4000244140625, "invlev_up": 771.79998779296875, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_324_generated", "manhole_dn": "manhole_325_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387248.355973182013258, 5858961.31797497626394 ], [ 1387199.500433639157563, 5858963.645901591517031 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1208", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 769.4000244140625, "invlev_up": 766.9000244140625, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_325_generated", "manhole_dn": "manhole_326_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387199.500433639157563, 5858963.645901591517031 ], [ 1387151.482699199579656, 5858977.583961015567183 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1209", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 762.60003662109375, "invlev_up": 766.9000244140625, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_326_generated", "manhole_dn": "manhole_327_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387151.482699199579656, 5858977.583961015567183 ], [ 1387103.632611613254994, 5858992.082134889438748 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1210", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 762.60003662109375, "invlev_up": 760.10003662109375, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_327_generated", "manhole_dn": "manhole_328_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387103.632611613254994, 5858992.082134889438748 ], [ 1387055.853339510038495, 5859006.816905959509313 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1211", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 755.79998779296875, "invlev_up": 760.10003662109375, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_328_generated", "manhole_dn": "manhole_329_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387055.853339510038495, 5859006.816905959509313 ], [ 1387008.074067406589165, 5859021.551677029579878 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1212", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_329_generated", "manhole_dn": "manhole_330_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387008.074067406589165, 5859021.551677029579878 ], [ 1386960.294795303372666, 5859036.286448099650443 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1213", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 749.5, "invlev_up": 753.29998779296875, "invlev_dn": 747.0, "manhole_up": "manhole_330_generated", "manhole_dn": "manhole_331_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386960.294795303372666, 5859036.286448099650443 ], [ 1386912.515523200156167, 5859051.021219169721007 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1214", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 749.5, "elevtn_dn": 749.5, "invlev_up": 747.0, "invlev_dn": 747.0, "manhole_up": "manhole_331_generated", "manhole_dn": "manhole_332_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386912.515523200156167, 5859051.021219169721007 ], [ 1386864.736251096706837, 5859065.755990239791572 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1215", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 749.5, "elevtn_dn": 727.10003662109375, "invlev_up": 747.0, "invlev_dn": 724.60003662109375, "manhole_up": "manhole_332_generated", "manhole_dn": "manhole_333_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386864.736251096706837, 5859065.755990239791572 ], [ 1386816.956978993490338, 5859080.490761309862137 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1216", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.10003662109375, "elevtn_dn": 752.29998779296875, "invlev_up": 724.60003662109375, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_333_generated", "manhole_dn": "manhole_334_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386816.956978993490338, 5859080.490761309862137 ], [ 1386769.832018451532349, 5859096.976014334708452 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1217", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 738.0, "invlev_up": 749.79998779296875, "invlev_dn": 735.5, "manhole_up": "manhole_334_generated", "manhole_dn": "manhole_335_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386769.832018451532349, 5859096.976014334708452 ], [ 1386724.102282747160643, 5859117.193917133845389 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1218", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 738.0, "invlev_up": 735.5, "invlev_dn": 735.5, "manhole_up": "manhole_335_generated", "manhole_dn": "manhole_336_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386724.102282747160643, 5859117.193917133845389 ], [ 1386678.372547042788938, 5859137.411819933913648 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1219", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 732.79998779296875, "invlev_up": 735.5, "invlev_dn": 730.29998779296875, "manhole_up": "manhole_336_generated", "manhole_dn": "manhole_337_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386678.372547042788938, 5859137.411819933913648 ], [ 1386632.642811338417232, 5859157.629722733050585 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1220", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.79998779296875, "elevtn_dn": 732.79998779296875, "invlev_up": 730.29998779296875, "invlev_dn": 730.29998779296875, "manhole_up": "manhole_337_generated", "manhole_dn": "manhole_338_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386632.642811338417232, 5859157.629722733050585 ], [ 1386586.913075634045526, 5859177.847625533118844 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1221", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.79998779296875, "elevtn_dn": 732.60003662109375, "invlev_up": 730.29998779296875, "invlev_dn": 730.10003662109375, "manhole_up": "manhole_338_generated", "manhole_dn": "manhole_339_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386586.913075634045526, 5859177.847625533118844 ], [ 1386541.181931287748739, 5859198.062337793409824 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1222", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.60003662109375, "elevtn_dn": 732.60003662109375, "invlev_up": 730.10003662109375, "invlev_dn": 730.10003662109375, "manhole_up": "manhole_339_generated", "manhole_dn": "manhole_340_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386541.181931287748739, 5859198.062337793409824 ], [ 1386495.431538854492828, 5859218.233453613705933 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1223", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.60003662109375, "elevtn_dn": 742.5, "invlev_up": 730.10003662109375, "invlev_dn": 740.0, "manhole_up": "manhole_340_generated", "manhole_dn": "manhole_341_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386495.431538854492828, 5859218.233453613705933 ], [ 1386449.681146421469748, 5859238.404569433070719 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1224", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 742.5, "invlev_up": 740.0, "invlev_dn": 740.0, "manhole_up": "manhole_341_generated", "manhole_dn": "manhole_342_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386449.681146421469748, 5859238.404569433070719 ], [ 1386404.749107032548636, 5859260.314221715554595 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1225", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 717.60003662109375, "invlev_up": 740.0, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_342_generated", "manhole_dn": "manhole_343_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386404.749107032548636, 5859260.314221715554595 ], [ 1386360.756595908896998, 5859284.020064728334546 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1226", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 717.60003662109375, "invlev_up": 715.10003662109375, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_343_generated", "manhole_dn": "manhole_344_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386360.756595908896998, 5859284.020064728334546 ], [ 1386317.622744857333601, 5859309.307279178872705 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1227", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 711.0, "invlev_up": 715.10003662109375, "invlev_dn": 708.5, "manhole_up": "manhole_344_generated", "manhole_dn": "manhole_345_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386317.622744857333601, 5859309.307279178872705 ], [ 1386274.488893805770203, 5859334.594493629410863 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1228", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 711.0, "elevtn_dn": 717.60003662109375, "invlev_up": 708.5, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_345_generated", "manhole_dn": "manhole_346_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386274.488893805770203, 5859334.594493629410863 ], [ 1386231.354723542230204, 5859359.881163572892547 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1229", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 739.0, "invlev_up": 715.10003662109375, "invlev_dn": 736.5, "manhole_up": "manhole_346_generated", "manhole_dn": "manhole_347_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386231.354723542230204, 5859359.881163572892547 ], [ 1386188.788941488368437, 5859385.978958465158939 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1230", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 739.0, "invlev_up": 736.5, "invlev_dn": 736.5, "manhole_up": "manhole_347_generated", "manhole_dn": "manhole_348_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386188.788941488368437, 5859385.978958465158939 ], [ 1386153.170269979629666, 5859420.751348914578557 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1231", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 739.0, "invlev_up": 736.5, "invlev_dn": 736.5, "manhole_up": "manhole_348_generated", "manhole_dn": "manhole_349_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386153.170269979629666, 5859420.751348914578557 ], [ 1386127.241226618411019, 5859463.08446778729558 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1232", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 770.60003662109375, "invlev_up": 736.5, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_349_generated", "manhole_dn": "manhole_350_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386127.241226618411019, 5859463.08446778729558 ], [ 1386108.996456971857697, 5859509.052053713239729 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1233", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_350_generated", "manhole_dn": "manhole_351_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386108.996456971857697, 5859509.052053713239729 ], [ 1386105.954033384332433, 5859558.959127158857882 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1234", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_351_generated", "manhole_dn": "manhole_352_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386105.954033384332433, 5859558.959127158857882 ], [ 1386101.917093347059563, 5859608.782215913757682 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1235", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 779.79998779296875, "invlev_up": 768.10003662109375, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_352_generated", "manhole_dn": "manhole_353_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386101.917093347059563, 5859608.782215913757682 ], [ 1386088.458339030388743, 5859656.652665913105011 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1236", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 779.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_353_generated", "manhole_dn": "manhole_354_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386088.458339030388743, 5859656.652665913105011 ], [ 1386075.652030121767893, 5859704.419184413738549 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1237", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 779.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_354_generated", "manhole_dn": "manhole_355_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386075.652030121767893, 5859704.419184413738549 ], [ 1386076.574770522769541, 5859754.410392354242504 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1238", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_355_generated", "manhole_dn": "manhole_356_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386076.574770522769541, 5859754.410392354242504 ], [ 1386077.497510923538357, 5859804.401600294746459 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1239", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_356_generated", "manhole_dn": "manhole_357_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386077.497510923538357, 5859804.401600294746459 ], [ 1386078.420251324307173, 5859854.392808235250413 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E195", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 814.29998779296875, "elevtn_dn": 802.9000244140625, "invlev_up": 811.79998779296875, "invlev_dn": 800.4000244140625, "manhole_up": "manhole_358_generated", "manhole_dn": "manhole_359_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384050.267680946970358, 5856698.702001548372209 ], [ 1384085.778961833100766, 5856733.441067186184227 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E196", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.9000244140625, "elevtn_dn": 802.9000244140625, "invlev_up": 800.4000244140625, "invlev_dn": 800.4000244140625, "manhole_up": "manhole_359_generated", "manhole_dn": "manhole_360_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384085.778961833100766, 5856733.441067186184227 ], [ 1384122.993944165529683, 5856766.592179889790714 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E197", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.9000244140625, "elevtn_dn": 816.29998779296875, "invlev_up": 800.4000244140625, "invlev_dn": 813.79998779296875, "manhole_up": "manhole_360_generated", "manhole_dn": "manhole_361_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384122.993944165529683, 5856766.592179889790714 ], [ 1384160.350959801580757, 5856799.578122235834599 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E198", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.29998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 813.79998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_361_generated", "manhole_dn": "manhole_362_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384160.350959801580757, 5856799.578122235834599 ], [ 1384198.384374253917485, 5856831.724873264320195 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E199", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 798.29998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_362_generated", "manhole_dn": "manhole_363_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384198.384374253917485, 5856831.724873264320195 ], [ 1384230.112839305773377, 5856870.159957353956997 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E200", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 793.9000244140625, "invlev_up": 798.29998779296875, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_363_generated", "manhole_dn": "manhole_364_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384230.112839305773377, 5856870.159957353956997 ], [ 1384259.121702386764809, 5856910.628996902145445 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E201", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 807.60003662109375, "invlev_up": 791.4000244140625, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_364_generated", "manhole_dn": "manhole_365_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384259.121702386764809, 5856910.628996902145445 ], [ 1384287.023718592710793, 5856951.925833041779697 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E202", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_365_generated", "manhole_dn": "manhole_366_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384287.023718592710793, 5856951.925833041779697 ], [ 1384314.929269487503916, 5856993.22028074786067 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E203", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_366_generated", "manhole_dn": "manhole_367_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384314.929269487503916, 5856993.22028074786067 ], [ 1384344.819752591196448, 5857033.056208833120763 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E204", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_367_generated", "manhole_dn": "manhole_368_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384344.819752591196448, 5857033.056208833120763 ], [ 1384375.891110281459987, 5857072.024425559677184 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E205", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_368_generated", "manhole_dn": "manhole_369_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384375.891110281459987, 5857072.024425559677184 ], [ 1384412.732155854580924, 5857105.507668288424611 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E206", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_369_generated", "manhole_dn": "manhole_370_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384412.732155854580924, 5857105.507668288424611 ], [ 1384450.07948348694481, 5857138.509612204506993 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E207", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_370_generated", "manhole_dn": "manhole_371_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384450.07948348694481, 5857138.509612204506993 ], [ 1384487.42686335532926, 5857171.511497005820274 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E208", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 805.0, "invlev_up": 793.4000244140625, "invlev_dn": 802.5, "manhole_up": "manhole_371_generated", "manhole_dn": "manhole_372_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384487.42686335532926, 5857171.511497005820274 ], [ 1384525.207759798038751, 5857204.014277670532465 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E209", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 796.29998779296875, "invlev_up": 802.5, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_372_generated", "manhole_dn": "manhole_373_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384525.207759798038751, 5857204.014277670532465 ], [ 1384563.111988977529109, 5857236.375065575353801 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E210", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 796.29998779296875, "invlev_up": 793.79998779296875, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_373_generated", "manhole_dn": "manhole_374_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384563.111988977529109, 5857236.375065575353801 ], [ 1384601.016218156786636, 5857268.735853480175138 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E211", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 786.10003662109375, "invlev_up": 793.79998779296875, "invlev_dn": 783.60003662109375, "manhole_up": "manhole_374_generated", "manhole_dn": "manhole_375_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384601.016218156786636, 5857268.735853480175138 ], [ 1384638.920447336044163, 5857301.096641384996474 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E212", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.10003662109375, "elevtn_dn": 794.29998779296875, "invlev_up": 783.60003662109375, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_375_generated", "manhole_dn": "manhole_376_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384638.920447336044163, 5857301.096641384996474 ], [ 1384669.604954990325496, 5857340.313404724933207 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E213", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 794.29998779296875, "invlev_up": 791.79998779296875, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_376_generated", "manhole_dn": "manhole_377_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384669.604954990325496, 5857340.313404724933207 ], [ 1384699.518247769214213, 5857380.104403200559318 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E214", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 794.29998779296875, "invlev_up": 791.79998779296875, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_377_generated", "manhole_dn": "manhole_378_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384699.518247769214213, 5857380.104403200559318 ], [ 1384719.806332413339987, 5857425.627417215146124 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E215", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 782.0, "invlev_up": 791.79998779296875, "invlev_dn": 779.5, "manhole_up": "manhole_378_generated", "manhole_dn": "manhole_379_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384719.806332413339987, 5857425.627417215146124 ], [ 1384740.094417057465762, 5857471.150431229732931 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E216", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 782.0, "elevtn_dn": 789.70001220703125, "invlev_up": 779.5, "invlev_dn": 787.20001220703125, "manhole_up": "manhole_379_generated", "manhole_dn": "manhole_380_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384740.094417057465762, 5857471.150431229732931 ], [ 1384760.382501701591536, 5857516.673445244319737 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E217", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 789.70001220703125, "elevtn_dn": 789.70001220703125, "invlev_up": 787.20001220703125, "invlev_dn": 787.20001220703125, "manhole_up": "manhole_380_generated", "manhole_dn": "manhole_381_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384760.382501701591536, 5857516.673445244319737 ], [ 1384780.670586345717311, 5857562.196459258906543 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E218", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 789.70001220703125, "elevtn_dn": 796.5, "invlev_up": 787.20001220703125, "invlev_dn": 794.0, "manhole_up": "manhole_381_generated", "manhole_dn": "manhole_382_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384780.670586345717311, 5857562.196459258906543 ], [ 1384802.672203443944454, 5857606.838341221213341 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E219", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.5, "elevtn_dn": 771.9000244140625, "invlev_up": 794.0, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_382_generated", "manhole_dn": "manhole_383_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384802.672203443944454, 5857606.838341221213341 ], [ 1384827.896526007680222, 5857649.823044718243182 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E220", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_383_generated", "manhole_dn": "manhole_384_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384827.896526007680222, 5857649.823044718243182 ], [ 1384854.757882944308221, 5857691.606820800341666 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E221", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_384_generated", "manhole_dn": "manhole_385_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384854.757882944308221, 5857691.606820800341666 ], [ 1384888.185768931638449, 5857728.573395187035203 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E222", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_385_generated", "manhole_dn": "manhole_386_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384888.185768931638449, 5857728.573395187035203 ], [ 1384921.613654918735847, 5857765.539969574660063 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E223", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 755.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_386_generated", "manhole_dn": "manhole_387_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384921.613654918735847, 5857765.539969574660063 ], [ 1384956.145453942706808, 5857801.445756647735834 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E224", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 755.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_387_generated", "manhole_dn": "manhole_388_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384956.145453942706808, 5857801.445756647735834 ], [ 1384991.751306539867073, 5857836.319449373520911 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E225", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 746.0, "invlev_up": 755.4000244140625, "invlev_dn": 743.5, "manhole_up": "manhole_388_generated", "manhole_dn": "manhole_389_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384991.751306539867073, 5857836.319449373520911 ], [ 1385027.357159137027338, 5857871.193142099305987 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E226", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 746.0, "elevtn_dn": 755.79998779296875, "invlev_up": 743.5, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_389_generated", "manhole_dn": "manhole_390_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385027.357159137027338, 5857871.193142099305987 ], [ 1385062.963011734187603, 5857906.066834825091064 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E227", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 728.60003662109375, "invlev_up": 753.29998779296875, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_390_generated", "manhole_dn": "manhole_391_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385062.963011734187603, 5857906.066834825091064 ], [ 1385098.568864331347868, 5857940.940527551807463 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E228", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 728.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_391_generated", "manhole_dn": "manhole_392_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385098.568864331347868, 5857940.940527551807463 ], [ 1385135.753846400883049, 5857974.029479116201401 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E229", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 728.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_392_generated", "manhole_dn": "manhole_393_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385135.753846400883049, 5857974.029479116201401 ], [ 1385175.738456205930561, 5858003.622975903563201 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E230", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 735.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 733.10003662109375, "manhole_up": "manhole_393_generated", "manhole_dn": "manhole_394_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385175.738456205930561, 5858003.622975903563201 ], [ 1385218.653756857383996, 5858028.965196672827005 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E231", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 735.60003662109375, "elevtn_dn": 735.60003662109375, "invlev_up": 733.10003662109375, "invlev_dn": 733.10003662109375, "manhole_up": "manhole_394_generated", "manhole_dn": "manhole_395_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385218.653756857383996, 5858028.965196672827005 ], [ 1385262.454936756985262, 5858052.706982978619635 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E232", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 735.60003662109375, "elevtn_dn": 742.0, "invlev_up": 733.10003662109375, "invlev_dn": 739.5, "manhole_up": "manhole_395_generated", "manhole_dn": "manhole_396_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385262.454936756985262, 5858052.706982978619635 ], [ 1385306.715555034345016, 5858075.618745312094688 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E233", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.0, "elevtn_dn": 742.0, "invlev_up": 739.5, "invlev_dn": 739.5, "manhole_up": "manhole_396_generated", "manhole_dn": "manhole_397_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385306.715555034345016, 5858075.618745312094688 ], [ 1385350.97617331170477, 5858098.530507644638419 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E234", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.0, "elevtn_dn": 736.0, "invlev_up": 739.5, "invlev_dn": 733.5, "manhole_up": "manhole_397_generated", "manhole_dn": "manhole_398_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385350.97617331170477, 5858098.530507644638419 ], [ 1385395.236791589297354, 5858121.442269978113472 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E235", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 736.0, "elevtn_dn": 736.0, "invlev_up": 733.5, "invlev_dn": 733.5, "manhole_up": "manhole_398_generated", "manhole_dn": "manhole_399_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385395.236791589297354, 5858121.442269978113472 ], [ 1385439.497409866657108, 5858144.354032310657203 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E236", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 736.0, "elevtn_dn": 737.9000244140625, "invlev_up": 733.5, "invlev_dn": 735.4000244140625, "manhole_up": "manhole_399_generated", "manhole_dn": "manhole_400_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385439.497409866657108, 5858144.354032310657203 ], [ 1385483.758028144016862, 5858167.265794644132257 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E237", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.9000244140625, "elevtn_dn": 737.9000244140625, "invlev_up": 735.4000244140625, "invlev_dn": 735.4000244140625, "manhole_up": "manhole_400_generated", "manhole_dn": "manhole_401_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385483.758028144016862, 5858167.265794644132257 ], [ 1385528.018646421376616, 5858190.17755697760731 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E238", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.9000244140625, "elevtn_dn": 727.29998779296875, "invlev_up": 735.4000244140625, "invlev_dn": 724.79998779296875, "manhole_up": "manhole_401_generated", "manhole_dn": "manhole_402_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385528.018646421376616, 5858190.17755697760731 ], [ 1385571.606102279853076, 5858214.277655217796564 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E239", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.29998779296875, "elevtn_dn": 727.29998779296875, "invlev_up": 724.79998779296875, "invlev_dn": 724.79998779296875, "manhole_up": "manhole_402_generated", "manhole_dn": "manhole_403_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385571.606102279853076, 5858214.277655217796564 ], [ 1385614.013400863157585, 5858240.461089110001922 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E240", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.29998779296875, "elevtn_dn": 690.60003662109375, "invlev_up": 724.79998779296875, "invlev_dn": 688.10003662109375, "manhole_up": "manhole_403_generated", "manhole_dn": "manhole_404_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385614.013400863157585, 5858240.461089110001922 ], [ 1385656.420699446462095, 5858266.644523002207279 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E241", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 690.60003662109375, "elevtn_dn": 733.60003662109375, "invlev_up": 688.10003662109375, "invlev_dn": 731.10003662109375, "manhole_up": "manhole_404_generated", "manhole_dn": "manhole_405_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385656.420699446462095, 5858266.644523002207279 ], [ 1385698.773111530812457, 5858292.8961898451671 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E242", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 733.60003662109375, "elevtn_dn": 733.60003662109375, "invlev_up": 731.10003662109375, "invlev_dn": 731.10003662109375, "manhole_up": "manhole_405_generated", "manhole_dn": "manhole_406_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385698.773111530812457, 5858292.8961898451671 ], [ 1385733.435650466475636, 5858328.707634637132287 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E243", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 733.60003662109375, "elevtn_dn": 721.60003662109375, "invlev_up": 731.10003662109375, "invlev_dn": 719.10003662109375, "manhole_up": "manhole_406_generated", "manhole_dn": "manhole_407_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385733.435650466475636, 5858328.707634637132287 ], [ 1385768.098189401905984, 5858364.519079428166151 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E244", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 721.60003662109375, "elevtn_dn": 721.60003662109375, "invlev_up": 719.10003662109375, "invlev_dn": 719.10003662109375, "manhole_up": "manhole_407_generated", "manhole_dn": "manhole_408_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385768.098189401905984, 5858364.519079428166151 ], [ 1385795.882535298354924, 5858405.467093757353723 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E245", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 721.60003662109375, "elevtn_dn": 739.0, "invlev_up": 719.10003662109375, "invlev_dn": 736.5, "manhole_up": "manhole_408_generated", "manhole_dn": "manhole_409_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385795.882535298354924, 5858405.467093757353723 ], [ 1385820.377634756267071, 5858448.871486231684685 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E246", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 727.79998779296875, "invlev_up": 736.5, "invlev_dn": 725.29998779296875, "manhole_up": "manhole_409_generated", "manhole_dn": "manhole_410_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385820.377634756267071, 5858448.871486231684685 ], [ 1385841.084314390551299, 5858493.920932004228234 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E247", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.79998779296875, "elevtn_dn": 727.79998779296875, "invlev_up": 725.29998779296875, "invlev_dn": 725.29998779296875, "manhole_up": "manhole_410_generated", "manhole_dn": "manhole_411_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385841.084314390551299, 5858493.920932004228234 ], [ 1385856.076261736918241, 5858541.451897682622075 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E248", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.79998779296875, "elevtn_dn": 734.9000244140625, "invlev_up": 725.29998779296875, "invlev_dn": 732.4000244140625, "manhole_up": "manhole_411_generated", "manhole_dn": "manhole_412_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385856.076261736918241, 5858541.451897682622075 ], [ 1385865.668899663724005, 5858590.250006795860827 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E249", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 734.9000244140625, "elevtn_dn": 734.9000244140625, "invlev_up": 732.4000244140625, "invlev_dn": 732.4000244140625, "manhole_up": "manhole_412_generated", "manhole_dn": "manhole_413_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385865.668899663724005, 5858590.250006795860827 ], [ 1385873.387286560609937, 5858639.487976770848036 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E250", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 734.9000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 732.4000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_413_generated", "manhole_dn": "manhole_414_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385873.387286560609937, 5858639.487976770848036 ], [ 1385875.017949819331989, 5858689.287253175862134 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E251", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 748.9000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_414_generated", "manhole_dn": "manhole_415_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385875.017949819331989, 5858689.287253175862134 ], [ 1385876.432928551919758, 5858739.106416343711317 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E252", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 748.9000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_415_generated", "manhole_dn": "manhole_416_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385876.432928551919758, 5858739.106416343711317 ], [ 1385878.329821793129668, 5858788.908141564577818 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E253", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 748.9000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_416_generated", "manhole_dn": "manhole_417_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385878.329821793129668, 5858788.908141564577818 ], [ 1385880.51921496167779, 5858838.69928275514394 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E254", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_417_generated", "manhole_dn": "manhole_418_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385880.51921496167779, 5858838.69928275514394 ], [ 1385882.620351102668792, 5858888.493530485779047 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E255", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_418_generated", "manhole_dn": "manhole_419_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385882.620351102668792, 5858888.493530485779047 ], [ 1385883.937443709466606, 5858938.315377607010305 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E256", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 766.10003662109375, "invlev_up": 757.20001220703125, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_419_generated", "manhole_dn": "manhole_420_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385883.937443709466606, 5858938.315377607010305 ], [ 1385885.254538560518995, 5858988.137224668636918 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E257", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 766.10003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_420_generated", "manhole_dn": "manhole_421_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385885.254538560518995, 5858988.137224668636918 ], [ 1385890.650534195825458, 5859037.630400610156357 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E258", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 766.10003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_421_generated", "manhole_dn": "manhole_422_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385890.650534195825458, 5859037.630400610156357 ], [ 1385901.777442803606391, 5859086.09239396546036 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E259", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 768.60003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 766.10003662109375, "manhole_up": "manhole_422_generated", "manhole_dn": "manhole_423_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385901.777442803606391, 5859086.09239396546036 ], [ 1385915.397954803425819, 5859134.03436760418117 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E260", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.60003662109375, "elevtn_dn": 762.79998779296875, "invlev_up": 766.10003662109375, "invlev_dn": 760.29998779296875, "manhole_up": "manhole_423_generated", "manhole_dn": "manhole_424_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385915.397954803425819, 5859134.03436760418117 ], [ 1385928.42605347908102, 5859182.139209139160812 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E261", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.79998779296875, "elevtn_dn": 762.5, "invlev_up": 760.29998779296875, "invlev_dn": 760.0, "manhole_up": "manhole_424_generated", "manhole_dn": "manhole_425_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385928.42605347908102, 5859182.139209139160812 ], [ 1385941.228082312969491, 5859230.306202415376902 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E262", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 762.5, "invlev_up": 760.0, "invlev_dn": 760.0, "manhole_up": "manhole_425_generated", "manhole_dn": "manhole_426_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385941.228082312969491, 5859230.306202415376902 ], [ 1385945.092689140234143, 5859279.734331246465445 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E263", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 762.5, "invlev_up": 760.0, "invlev_dn": 760.0, "manhole_up": "manhole_426_generated", "manhole_dn": "manhole_427_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385945.092689140234143, 5859279.734331246465445 ], [ 1385937.902412303024903, 5859328.779896341264248 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E264", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 778.0, "invlev_up": 760.0, "invlev_dn": 775.5, "manhole_up": "manhole_427_generated", "manhole_dn": "manhole_428_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.902412303024903, 5859328.779896341264248 ], [ 1385932.795075723901391, 5859378.173214216716588 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E265", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 778.0, "invlev_up": 775.5, "invlev_dn": 775.5, "manhole_up": "manhole_428_generated", "manhole_dn": "manhole_429_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385932.795075723901391, 5859378.173214216716588 ], [ 1385937.702695531537756, 5859427.770254967734218 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E266", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 778.0, "invlev_up": 775.5, "invlev_dn": 775.5, "manhole_up": "manhole_429_generated", "manhole_dn": "manhole_430_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.702695531537756, 5859427.770254967734218 ], [ 1385939.035937832202762, 5859477.50230407807976 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E267", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 795.9000244140625, "invlev_up": 775.5, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_430_generated", "manhole_dn": "manhole_431_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385939.035937832202762, 5859477.50230407807976 ], [ 1385937.883638251805678, 5859527.328234969638288 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E268", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_431_generated", "manhole_dn": "manhole_432_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.883638251805678, 5859527.328234969638288 ], [ 1385940.515994266141206, 5859576.989168248139322 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E269", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_432_generated", "manhole_dn": "manhole_433_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385940.515994266141206, 5859576.989168248139322 ], [ 1385950.701545101590455, 5859625.530176519416273 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E270", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 815.0, "invlev_up": 793.4000244140625, "invlev_dn": 812.5, "manhole_up": "manhole_433_generated", "manhole_dn": "manhole_434_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385950.701545101590455, 5859625.530176519416273 ], [ 1385970.467743494315073, 5859670.991298755630851 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E271", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 815.0, "elevtn_dn": 815.0, "invlev_up": 812.5, "invlev_dn": 812.5, "manhole_up": "manhole_434_generated", "manhole_dn": "manhole_435_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385970.467743494315073, 5859670.991298755630851 ], [ 1386011.983088220236823, 5859697.862916950136423 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E272", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 815.0, "elevtn_dn": 779.79998779296875, "invlev_up": 812.5, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_435_generated", "manhole_dn": "manhole_436_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386011.983088220236823, 5859697.862916950136423 ], [ 1386052.213596233632416, 5859727.119808158837259 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E273", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_436_generated", "manhole_dn": "manhole_437_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386052.213596233632416, 5859727.119808158837259 ], [ 1386046.501012831227854, 5859771.612671964801848 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E274", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_437_generated", "manhole_dn": "manhole_438_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386046.501012831227854, 5859771.612671964801848 ], [ 1386026.809695787727833, 5859816.873920152895153 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E275", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_438_generated", "manhole_dn": "manhole_439_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386026.809695787727833, 5859816.873920152895153 ], [ 1386030.149607364553958, 5859866.379009906202555 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E276", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_439_generated", "manhole_dn": "manhole_440_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386030.149607364553958, 5859866.379009906202555 ], [ 1386045.250939248362556, 5859913.859036295674741 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 798.29998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_441_generated", "manhole_dn": "manhole_442_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384196.861816460033879, 5856829.88048410974443 ], [ 1384235.22519311751239, 5856854.977665597572923 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 793.9000244140625, "invlev_up": 798.29998779296875, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_442_generated", "manhole_dn": "manhole_443_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384235.22519311751239, 5856854.977665597572923 ], [ 1384263.450329831801355, 5856892.038370934315026 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 793.9000244140625, "invlev_up": 791.4000244140625, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_443_generated", "manhole_dn": "manhole_444_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384263.450329831801355, 5856892.038370934315026 ], [ 1384291.675466545857489, 5856929.099076271057129 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 807.60003662109375, "invlev_up": 791.4000244140625, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_444_generated", "manhole_dn": "manhole_445_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384291.675466545857489, 5856929.099076271057129 ], [ 1384319.900603260146454, 5856966.159781608730555 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_445_generated", "manhole_dn": "manhole_446_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384319.900603260146454, 5856966.159781608730555 ], [ 1384347.205867683747783, 5857003.894510924816132 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 799.0, "invlev_up": 805.10003662109375, "invlev_dn": 796.5, "manhole_up": "manhole_446_generated", "manhole_dn": "manhole_447_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384347.205867683747783, 5857003.894510924816132 ], [ 1384380.322691001230851, 5857036.360282040201128 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 799.0, "elevtn_dn": 807.60003662109375, "invlev_up": 796.5, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_447_generated", "manhole_dn": "manhole_448_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384380.322691001230851, 5857036.360282040201128 ], [ 1384415.156610523350537, 5857067.291694445535541 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_448_generated", "manhole_dn": "manhole_449_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384415.156610523350537, 5857067.291694445535541 ], [ 1384449.343575850594789, 5857098.828100205399096 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_449_generated", "manhole_dn": "manhole_450_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384449.343575850594789, 5857098.828100205399096 ], [ 1384470.004810179118067, 5857139.926174183376133 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_450_generated", "manhole_dn": "manhole_451_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384470.004810179118067, 5857139.926174183376133 ], [ 1384484.18076178082265, 5857184.301805094815791 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_452_generated", "manhole_dn": "manhole_453_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384289.06552429520525, 5856954.947841017507017 ], [ 1384305.049610810354352, 5856994.88734863139689 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_453_generated", "manhole_dn": "manhole_454_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384305.049610810354352, 5856994.88734863139689 ], [ 1384321.033697325503454, 5857034.82685624435544 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 799.0, "invlev_up": 805.10003662109375, "invlev_dn": 796.5, "manhole_up": "manhole_454_generated", "manhole_dn": "manhole_455_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384321.033697325503454, 5857034.82685624435544 ], [ 1384347.445656489115208, 5857068.672038841992617 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 799.0, "elevtn_dn": 807.60003662109375, "invlev_up": 796.5, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_455_generated", "manhole_dn": "manhole_456_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384347.445656489115208, 5857068.672038841992617 ], [ 1384374.130628447979689, 5857102.406951548531651 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_456_generated", "manhole_dn": "manhole_457_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384374.130628447979689, 5857102.406951548531651 ], [ 1384399.587644136510789, 5857137.08541233278811 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_457_generated", "manhole_dn": "manhole_458_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384399.587644136510789, 5857137.08541233278811 ], [ 1384425.04465982504189, 5857171.763873117044568 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_458_generated", "manhole_dn": "manhole_459_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384425.04465982504189, 5857171.763873117044568 ], [ 1384456.866520966170356, 5857200.577977900393307 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_15_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_15", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_15", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_459_generated", "manhole_dn": "manhole_460_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384456.866520966170356, 5857200.577977900393307 ], [ 1384480.774830641923472, 5857195.244455400854349 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_17_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_17", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_17", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 805.0, "invlev_up": 793.4000244140625, "invlev_dn": 802.5, "manhole_up": "manhole_459_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384456.866520966170356, 5857200.577977900393307 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_18_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_18", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_18", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_462_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384493.329776774393395, 5857201.952337642200291 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_19_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_19", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_19", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_462_generated", "manhole_dn": "manhole_463_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384493.329776774393395, 5857201.952337642200291 ], [ 1384511.321100181667134, 5857246.008046119473875 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_19_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_19", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_19", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_463_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384511.321100181667134, 5857246.008046119473875 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 796.29998779296875, "invlev_up": 802.5, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_464_generated", "manhole_dn": "manhole_465_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384512.484966830350459, 5857248.858029337599874 ], [ 1384550.208547196350992, 5857281.609186780638993 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 796.29998779296875, "invlev_up": 793.79998779296875, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_465_generated", "manhole_dn": "manhole_466_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384550.208547196350992, 5857281.609186780638993 ], [ 1384587.932127562351525, 5857314.360344224609435 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 809.10003662109375, "invlev_up": 793.79998779296875, "invlev_dn": 806.60003662109375, "manhole_up": "manhole_466_generated", "manhole_dn": "manhole_467_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384587.932127562351525, 5857314.360344224609435 ], [ 1384608.456866907887161, 5857358.785165345296264 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.10003662109375, "elevtn_dn": 809.10003662109375, "invlev_up": 806.60003662109375, "invlev_dn": 806.60003662109375, "manhole_up": "manhole_467_generated", "manhole_dn": "manhole_468_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384608.456866907887161, 5857358.785165345296264 ], [ 1384624.966163935838267, 5857405.935456342995167 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.10003662109375, "elevtn_dn": 794.29998779296875, "invlev_up": 806.60003662109375, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_468_generated", "manhole_dn": "manhole_469_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384624.966163935838267, 5857405.935456342995167 ], [ 1384639.938245237572119, 5857453.586039477027953 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 812.4000244140625, "invlev_up": 791.79998779296875, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_469_generated", "manhole_dn": "manhole_470_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384639.938245237572119, 5857453.586039477027953 ], [ 1384654.3423755497206, 5857501.421464210376143 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 812.4000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_470_generated", "manhole_dn": "manhole_471_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384654.3423755497206, 5857501.421464210376143 ], [ 1384665.748858094681054, 5857550.055336253717542 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 812.4000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_471_generated", "manhole_dn": "manhole_472_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384665.748858094681054, 5857550.055336253717542 ], [ 1384677.04772660904564, 5857598.717872150242329 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 818.9000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 816.4000244140625, "manhole_up": "manhole_472_generated", "manhole_dn": "manhole_473_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384677.04772660904564, 5857598.717872150242329 ], [ 1384688.346595123410225, 5857647.380408045835793 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.9000244140625, "elevtn_dn": 818.9000244140625, "invlev_up": 816.4000244140625, "invlev_dn": 816.4000244140625, "manhole_up": "manhole_473_generated", "manhole_dn": "manhole_474_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384688.346595123410225, 5857647.380408045835793 ], [ 1384699.64546363777481, 5857696.042943941429257 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.9000244140625, "elevtn_dn": 791.0, "invlev_up": 816.4000244140625, "invlev_dn": 788.5, "manhole_up": "manhole_474_generated", "manhole_dn": "manhole_475_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384699.64546363777481, 5857696.042943941429257 ], [ 1384710.944332152139395, 5857744.705479837954044 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 771.9000244140625, "invlev_up": 788.5, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_475_generated", "manhole_dn": "manhole_476_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384710.944332152139395, 5857744.705479837954044 ], [ 1384726.848783193388954, 5857791.671307560056448 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_476_generated", "manhole_dn": "manhole_477_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384726.848783193388954, 5857791.671307560056448 ], [ 1384753.929338480113074, 5857833.199649352580309 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_477_generated", "manhole_dn": "manhole_478_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384753.929338480113074, 5857833.199649352580309 ], [ 1384783.627482200739905, 5857873.006575288251042 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 791.0, "invlev_up": 769.4000244140625, "invlev_dn": 788.5, "manhole_up": "manhole_478_generated", "manhole_dn": "manhole_479_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384783.627482200739905, 5857873.006575288251042 ], [ 1384795.018452654592693, 5857920.637507135979831 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 791.0, "invlev_up": 788.5, "invlev_dn": 788.5, "manhole_up": "manhole_479_generated", "manhole_dn": "manhole_480_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384795.018452654592693, 5857920.637507135979831 ], [ 1384785.075932276435196, 5857969.445633230730891 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 820.10003662109375, "invlev_up": 788.5, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_480_generated", "manhole_dn": "manhole_481_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384785.075932276435196, 5857969.445633230730891 ], [ 1384771.479073295136914, 5858017.516749874688685 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 820.10003662109375, "invlev_up": 817.60003662109375, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_481_generated", "manhole_dn": "manhole_482_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384771.479073295136914, 5858017.516749874688685 ], [ 1384763.32518996251747, 5858066.675425447523594 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 820.10003662109375, "invlev_up": 817.60003662109375, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_482_generated", "manhole_dn": "manhole_483_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384763.32518996251747, 5858066.675425447523594 ], [ 1384757.405406558187678, 5858116.280495692044497 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 847.0, "invlev_up": 817.60003662109375, "invlev_dn": 844.5, "manhole_up": "manhole_483_generated", "manhole_dn": "manhole_484_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384757.405406558187678, 5858116.280495692044497 ], [ 1384746.211964494548738, 5858164.956996791996062 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 847.0, "invlev_up": 844.5, "invlev_dn": 844.5, "manhole_up": "manhole_484_generated", "manhole_dn": "manhole_485_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384746.211964494548738, 5858164.956996791996062 ], [ 1384738.028054837835953, 5858213.862443570047617 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 847.0, "invlev_up": 844.5, "invlev_dn": 844.5, "manhole_up": "manhole_485_generated", "manhole_dn": "manhole_486_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384738.028054837835953, 5858213.862443570047617 ], [ 1384756.479259133106098, 5858259.218586039729416 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 833.20001220703125, "invlev_up": 844.5, "invlev_dn": 830.70001220703125, "manhole_up": "manhole_486_generated", "manhole_dn": "manhole_487_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384756.479259133106098, 5858259.218586039729416 ], [ 1384792.653981153853238, 5858293.25339647103101 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 833.20001220703125, "elevtn_dn": 762.29998779296875, "invlev_up": 830.70001220703125, "invlev_dn": 759.79998779296875, "manhole_up": "manhole_487_generated", "manhole_dn": "manhole_488_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384792.653981153853238, 5858293.25339647103101 ], [ 1384839.146884107263759, 5858310.949097327888012 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.29998779296875, "elevtn_dn": 762.29998779296875, "invlev_up": 759.79998779296875, "invlev_dn": 759.79998779296875, "manhole_up": "manhole_488_generated", "manhole_dn": "manhole_489_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384839.146884107263759, 5858310.949097327888012 ], [ 1384888.517509665805846, 5858307.535864246077836 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.29998779296875, "elevtn_dn": 751.0, "invlev_up": 759.79998779296875, "invlev_dn": 748.5, "manhole_up": "manhole_489_generated", "manhole_dn": "manhole_490_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384888.517509665805846, 5858307.535864246077836 ], [ 1384936.622762819286436, 5858294.068231076002121 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.0, "elevtn_dn": 751.0, "invlev_up": 748.5, "invlev_dn": 748.5, "manhole_up": "manhole_490_generated", "manhole_dn": "manhole_491_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384936.622762819286436, 5858294.068231076002121 ], [ 1384984.637113286415115, 5858280.272530450485647 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.0, "elevtn_dn": 743.20001220703125, "invlev_up": 748.5, "invlev_dn": 740.70001220703125, "manhole_up": "manhole_491_generated", "manhole_dn": "manhole_492_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384984.637113286415115, 5858280.272530450485647 ], [ 1385032.633651287527755, 5858266.414710656739771 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 743.20001220703125, "elevtn_dn": 743.20001220703125, "invlev_up": 740.70001220703125, "invlev_dn": 740.70001220703125, "manhole_up": "manhole_492_generated", "manhole_dn": "manhole_493_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385032.633651287527755, 5858266.414710656739771 ], [ 1385081.886840383987874, 5858258.136644747108221 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 743.20001220703125, "elevtn_dn": 747.60003662109375, "invlev_up": 740.70001220703125, "invlev_dn": 745.10003662109375, "manhole_up": "manhole_493_generated", "manhole_dn": "manhole_494_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385081.886840383987874, 5858258.136644747108221 ], [ 1385131.310463621048257, 5858263.211211345158517 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.60003662109375, "elevtn_dn": 756.79998779296875, "invlev_up": 745.10003662109375, "invlev_dn": 754.29998779296875, "manhole_up": "manhole_494_generated", "manhole_dn": "manhole_495_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385131.310463621048257, 5858263.211211345158517 ], [ 1385177.729395114118233, 5858281.168494092300534 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.79998779296875, "elevtn_dn": 758.9000244140625, "invlev_up": 754.29998779296875, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_495_generated", "manhole_dn": "manhole_496_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385177.729395114118233, 5858281.168494092300534 ], [ 1385219.95651927171275, 5858307.84242575801909 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 758.9000244140625, "invlev_up": 756.4000244140625, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_496_generated", "manhole_dn": "manhole_497_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385219.95651927171275, 5858307.84242575801909 ], [ 1385261.864506913116202, 5858335.034840167500079 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 756.29998779296875, "invlev_up": 756.4000244140625, "invlev_dn": 753.79998779296875, "manhole_up": "manhole_497_generated", "manhole_dn": "manhole_498_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385261.864506913116202, 5858335.034840167500079 ], [ 1385305.658712412696332, 5858358.964500648900867 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 756.29998779296875, "invlev_up": 753.79998779296875, "invlev_dn": 753.79998779296875, "manhole_up": "manhole_498_generated", "manhole_dn": "manhole_499_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385305.658712412696332, 5858358.964500648900867 ], [ 1385350.136275847908109, 5858381.712097893469036 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 750.79998779296875, "invlev_up": 753.79998779296875, "invlev_dn": 748.29998779296875, "manhole_up": "manhole_499_generated", "manhole_dn": "manhole_500_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385350.136275847908109, 5858381.712097893469036 ], [ 1385394.617425152566284, 5858404.452682325616479 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 750.79998779296875, "elevtn_dn": 760.20001220703125, "invlev_up": 748.29998779296875, "invlev_dn": 757.70001220703125, "manhole_up": "manhole_500_generated", "manhole_dn": "manhole_501_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385394.617425152566284, 5858404.452682325616479 ], [ 1385439.245915542822331, 5858426.901898948475718 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 760.20001220703125, "elevtn_dn": 754.29998779296875, "invlev_up": 757.70001220703125, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_501_generated", "manhole_dn": "manhole_502_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385439.245915542822331, 5858426.901898948475718 ], [ 1385483.926139793125913, 5858449.248809035867453 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 754.29998779296875, "invlev_up": 751.79998779296875, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_502_generated", "manhole_dn": "manhole_503_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385483.926139793125913, 5858449.248809035867453 ], [ 1385525.860647091642022, 5858475.8632338559255 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 754.29998779296875, "invlev_up": 751.79998779296875, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_503_generated", "manhole_dn": "manhole_504_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385525.860647091642022, 5858475.8632338559255 ], [ 1385553.357332118786871, 5858517.404887572862208 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 751.70001220703125, "invlev_up": 751.79998779296875, "invlev_dn": 749.20001220703125, "manhole_up": "manhole_504_generated", "manhole_dn": "manhole_505_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385553.357332118786871, 5858517.404887572862208 ], [ 1385579.617479301057756, 5858559.686364834196866 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.70001220703125, "elevtn_dn": 751.70001220703125, "invlev_up": 749.20001220703125, "invlev_dn": 749.20001220703125, "manhole_up": "manhole_505_generated", "manhole_dn": "manhole_506_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385579.617479301057756, 5858559.686364834196866 ], [ 1385621.905693766893819, 5858585.068030893802643 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.70001220703125, "elevtn_dn": 750.9000244140625, "invlev_up": 749.20001220703125, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_506_generated", "manhole_dn": "manhole_507_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385621.905693766893819, 5858585.068030893802643 ], [ 1385664.027273919200525, 5858611.351026647724211 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 750.9000244140625, "invlev_up": 748.4000244140625, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_507_generated", "manhole_dn": "manhole_508_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385664.027273919200525, 5858611.351026647724211 ], [ 1385700.387205619364977, 5858645.507954810746014 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 750.9000244140625, "invlev_up": 748.4000244140625, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_508_generated", "manhole_dn": "manhole_509_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385700.387205619364977, 5858645.507954810746014 ], [ 1385734.601841112133116, 5858681.909404612146318 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 755.79998779296875, "invlev_up": 748.4000244140625, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_509_generated", "manhole_dn": "manhole_510_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385734.601841112133116, 5858681.909404612146318 ], [ 1385768.816476604901254, 5858718.310854412615299 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_510_generated", "manhole_dn": "manhole_511_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385768.816476604901254, 5858718.310854412615299 ], [ 1385802.200311921536922, 5858755.447309947572649 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_511_generated", "manhole_dn": "manhole_512_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385802.200311921536922, 5858755.447309947572649 ], [ 1385834.15946239954792, 5858793.844178703613579 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_21_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 765.0, "invlev_up": 753.79998779296875, "invlev_dn": 762.5, "manhole_up": "manhole_513_generated", "manhole_dn": "manhole_514_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385352.471788094611838, 5858398.70255031902343 ], [ 1385323.609449510695413, 5858430.098599229939282 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_21_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.0, "elevtn_dn": 765.0, "invlev_up": 762.5, "invlev_dn": 762.5, "manhole_up": "manhole_514_generated", "manhole_dn": "manhole_515_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385323.609449510695413, 5858430.098599229939282 ], [ 1385286.388775944709778, 5858419.306091710925102 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_21_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.0, "elevtn_dn": 758.9000244140625, "invlev_up": 762.5, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_515_generated", "manhole_dn": "manhole_516_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385286.388775944709778, 5858419.306091710925102 ], [ 1385252.458742934046313, 5858394.201654580421746 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_21_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 758.9000244140625, "invlev_up": 756.4000244140625, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_516_generated", "manhole_dn": "manhole_517_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385252.458742934046313, 5858394.201654580421746 ], [ 1385217.536378393415362, 5858369.72360460460186 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_21_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 756.79998779296875, "invlev_up": 756.4000244140625, "invlev_dn": 754.29998779296875, "manhole_up": "manhole_517_generated", "manhole_dn": "manhole_518_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385217.536378393415362, 5858369.72360460460186 ], [ 1385177.877519500209019, 5858363.975667187944055 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_23_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_23", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "manhole_up": "manhole_519_generated", "manhole_dn": "manhole_520_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384748.107251951703802, 5858475.46539437584579 ], [ 1384773.662756133358926, 5858482.028828926384449 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_23_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_23", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "manhole_up": "manhole_520_generated", "manhole_dn": "manhole_521_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384773.662756133358926, 5858482.028828926384449 ], [ 1384799.21826031524688, 5858488.592263477854431 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_24_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_24", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_24", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.9000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 760.4000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_522_generated", "manhole_dn": "manhole_523_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385831.554474999429658, 5858837.476550582796335 ], [ 1385834.933234154479578, 5858795.367517679929733 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_24_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_24", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_24", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 748.9000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_523_generated", "manhole_dn": "manhole_524_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385834.933234154479578, 5858795.367517679929733 ], [ 1385855.640895856311545, 5858836.135079927742481 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_25_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_25", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.79998779296875, "elevtn_dn": 791.20001220703125, "invlev_up": 784.29998779296875, "invlev_dn": 788.70001220703125, "manhole_up": "manhole_525_generated", "manhole_dn": "manhole_526_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385425.871741503709927, 5858809.522038951516151 ], [ 1385446.216239683330059, 5858844.397748519666493 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_25_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_25", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.20001220703125, "elevtn_dn": 791.20001220703125, "invlev_up": 788.70001220703125, "invlev_dn": 788.70001220703125, "manhole_up": "manhole_526_generated", "manhole_dn": "manhole_527_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385446.216239683330059, 5858844.397748519666493 ], [ 1385453.998638280900195, 5858886.437654017470777 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_25_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_25", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.20001220703125, "elevtn_dn": 783.0, "invlev_up": 788.70001220703125, "invlev_dn": 780.5, "manhole_up": "manhole_527_generated", "manhole_dn": "manhole_528_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385453.998638280900195, 5858886.437654017470777 ], [ 1385472.218053022632375, 5858925.273072509095073 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_26_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_26", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_26", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.9000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 760.4000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_522_generated", "manhole_dn": "manhole_524_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385831.554474999429658, 5858837.476550582796335 ], [ 1385855.640895856311545, 5858836.135079927742481 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_29_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_29", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_29", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_529_generated", "manhole_dn": "manhole_530_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385861.372513797832653, 5858893.832569030113518 ], [ 1385844.630084188189358, 5858865.848266057670116 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_29_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_29", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_29", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 762.9000244140625, "invlev_up": 757.20001220703125, "invlev_dn": 760.4000244140625, "manhole_up": "manhole_530_generated", "manhole_dn": "manhole_522_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385844.630084188189358, 5858865.848266057670116 ], [ 1385831.554474999429658, 5858837.476550582796335 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 769.4000244140625, "invlev_up": 766.9000244140625, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_531_generated", "manhole_dn": "manhole_532_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387137.22300889948383, 5858981.723106959834695 ], [ 1387148.04859330272302, 5859026.366797789931297 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 762.60003662109375, "invlev_up": 766.9000244140625, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_532_generated", "manhole_dn": "manhole_533_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387148.04859330272302, 5859026.366797789931297 ], [ 1387119.95937648974359, 5859056.934598693624139 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 762.60003662109375, "invlev_up": 760.10003662109375, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_533_generated", "manhole_dn": "manhole_534_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387119.95937648974359, 5859056.934598693624139 ], [ 1387074.832296247361228, 5859065.30100557859987 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 755.79998779296875, "invlev_up": 760.10003662109375, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_534_generated", "manhole_dn": "manhole_535_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387074.832296247361228, 5859065.30100557859987 ], [ 1387030.356415221933275, 5859076.86137125454843 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 772.4000244140625, "invlev_up": 753.29998779296875, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_535_generated", "manhole_dn": "manhole_536_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387030.356415221933275, 5859076.86137125454843 ], [ 1386986.427998587489128, 5859090.309648380614817 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 761.60003662109375, "invlev_up": 769.9000244140625, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_536_generated", "manhole_dn": "manhole_537_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386986.427998587489128, 5859090.309648380614817 ], [ 1386945.966695382725447, 5859111.788386604748666 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_537_generated", "manhole_dn": "manhole_538_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386945.966695382725447, 5859111.788386604748666 ], [ 1386905.77102447184734, 5859134.105928846634924 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_538_generated", "manhole_dn": "manhole_539_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386905.77102447184734, 5859134.105928846634924 ], [ 1386871.537448140559718, 5859162.609670763835311 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_539_generated", "manhole_dn": "manhole_540_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386871.537448140559718, 5859162.609670763835311 ], [ 1386921.106019288301468, 5859163.103915391489863 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 772.4000244140625, "invlev_up": 759.10003662109375, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_540_generated", "manhole_dn": "manhole_541_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386921.106019288301468, 5859163.103915391489863 ], [ 1386970.627896018791944, 5859161.624508504755795 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 772.4000244140625, "invlev_up": 769.9000244140625, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_541_generated", "manhole_dn": "manhole_542_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386970.627896018791944, 5859161.624508504755795 ], [ 1387019.993600395740941, 5859157.412991388700902 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 781.10003662109375, "invlev_up": 769.9000244140625, "invlev_dn": 778.60003662109375, "manhole_up": "manhole_542_generated", "manhole_dn": "manhole_543_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387019.993600395740941, 5859157.412991388700902 ], [ 1387069.191225855611265, 5859151.340004274621606 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 781.10003662109375, "elevtn_dn": 781.10003662109375, "invlev_up": 778.60003662109375, "invlev_dn": 778.60003662109375, "manhole_up": "manhole_543_generated", "manhole_dn": "manhole_544_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387069.191225855611265, 5859151.340004274621606 ], [ 1387118.547863835236058, 5859146.828392788767815 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 781.10003662109375, "elevtn_dn": 786.4000244140625, "invlev_up": 778.60003662109375, "invlev_dn": 783.9000244140625, "manhole_up": "manhole_544_generated", "manhole_dn": "manhole_545_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387118.547863835236058, 5859146.828392788767815 ], [ 1387167.916038708761334, 5859151.025294326245785 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.4000244140625, "elevtn_dn": 786.4000244140625, "invlev_up": 783.9000244140625, "invlev_dn": 783.9000244140625, "manhole_up": "manhole_545_generated", "manhole_dn": "manhole_546_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387167.916038708761334, 5859151.025294326245785 ], [ 1387217.282604865729809, 5859155.523034786805511 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.4000244140625, "elevtn_dn": 787.60003662109375, "invlev_up": 783.9000244140625, "invlev_dn": 785.10003662109375, "manhole_up": "manhole_546_generated", "manhole_dn": "manhole_547_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387217.282604865729809, 5859155.523034786805511 ], [ 1387266.649171022465453, 5859160.020775248296559 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.60003662109375, "elevtn_dn": 787.60003662109375, "invlev_up": 785.10003662109375, "invlev_dn": 785.10003662109375, "manhole_up": "manhole_547_generated", "manhole_dn": "manhole_548_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387266.649171022465453, 5859160.020775248296559 ], [ 1387315.831188223091885, 5859165.716172898188233 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.60003662109375, "elevtn_dn": 790.4000244140625, "invlev_up": 785.10003662109375, "invlev_dn": 787.9000244140625, "manhole_up": "manhole_548_generated", "manhole_dn": "manhole_549_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387315.831188223091885, 5859165.716172898188233 ], [ 1387364.261764668161049, 5859176.288154195994139 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 790.4000244140625, "elevtn_dn": 790.4000244140625, "invlev_up": 787.9000244140625, "invlev_dn": 787.9000244140625, "manhole_up": "manhole_549_generated", "manhole_dn": "manhole_550_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387364.261764668161049, 5859176.288154195994139 ], [ 1387411.186259990092367, 5859192.118345031514764 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 790.4000244140625, "elevtn_dn": 789.10003662109375, "invlev_up": 787.9000244140625, "invlev_dn": 786.60003662109375, "manhole_up": "manhole_550_generated", "manhole_dn": "manhole_551_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387411.186259990092367, 5859192.118345031514764 ], [ 1387455.544592748628929, 5859213.906051598489285 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 789.10003662109375, "elevtn_dn": 817.20001220703125, "invlev_up": 786.60003662109375, "invlev_dn": 814.70001220703125, "manhole_up": "manhole_551_generated", "manhole_dn": "manhole_552_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387455.544592748628929, 5859213.906051598489285 ], [ 1387490.610425172373652, 5859248.94134864397347 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 817.20001220703125, "elevtn_dn": 818.20001220703125, "invlev_up": 814.70001220703125, "invlev_dn": 815.70001220703125, "manhole_up": "manhole_552_generated", "manhole_dn": "manhole_553_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387490.610425172373652, 5859248.94134864397347 ], [ 1387525.979065561201423, 5859283.669168318621814 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.20001220703125, "elevtn_dn": 818.20001220703125, "invlev_up": 815.70001220703125, "invlev_dn": 815.70001220703125, "manhole_up": "manhole_553_generated", "manhole_dn": "manhole_554_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387525.979065561201423, 5859283.669168318621814 ], [ 1387563.532416822388768, 5859316.0270627560094 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.20001220703125, "elevtn_dn": 802.79998779296875, "invlev_up": 815.70001220703125, "invlev_dn": 800.29998779296875, "manhole_up": "manhole_554_generated", "manhole_dn": "manhole_555_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387563.532416822388768, 5859316.0270627560094 ], [ 1387601.085768083808944, 5859348.384957193396986 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.79998779296875, "elevtn_dn": 837.70001220703125, "invlev_up": 800.29998779296875, "invlev_dn": 835.20001220703125, "manhole_up": "manhole_555_generated", "manhole_dn": "manhole_556_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387601.085768083808944, 5859348.384957193396986 ], [ 1387638.639119345229119, 5859380.742851630784571 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 837.70001220703125, "elevtn_dn": 837.70001220703125, "invlev_up": 835.20001220703125, "invlev_dn": 835.20001220703125, "manhole_up": "manhole_556_generated", "manhole_dn": "manhole_557_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387638.639119345229119, 5859380.742851630784571 ], [ 1387676.192470606416464, 5859413.100746068172157 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 837.70001220703125, "elevtn_dn": 828.79998779296875, "invlev_up": 835.20001220703125, "invlev_dn": 826.29998779296875, "manhole_up": "manhole_557_generated", "manhole_dn": "manhole_558_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387676.192470606416464, 5859413.100746068172157 ], [ 1387713.745821867836639, 5859445.45864050462842 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 828.79998779296875, "elevtn_dn": 828.79998779296875, "invlev_up": 826.29998779296875, "invlev_dn": 826.29998779296875, "manhole_up": "manhole_558_generated", "manhole_dn": "manhole_559_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387713.745821867836639, 5859445.45864050462842 ], [ 1387750.394377880264074, 5859478.825171477161348 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 828.79998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 826.29998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_559_generated", "manhole_dn": "manhole_560_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387750.394377880264074, 5859478.825171477161348 ], [ 1387786.626276910537854, 5859512.656178202480078 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 851.79998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_560_generated", "manhole_dn": "manhole_561_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387786.626276910537854, 5859512.656178202480078 ], [ 1387822.858175940578803, 5859546.487184926867485 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 851.79998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_561_generated", "manhole_dn": "manhole_562_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387822.858175940578803, 5859546.487184926867485 ], [ 1387850.662340233800933, 5859586.980695966631174 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 891.20001220703125, "invlev_up": 851.79998779296875, "invlev_dn": 888.70001220703125, "manhole_up": "manhole_562_generated", "manhole_dn": "manhole_563_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387850.662340233800933, 5859586.980695966631174 ], [ 1387868.193221996771172, 5859633.330900657922029 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.20001220703125, "elevtn_dn": 876.20001220703125, "invlev_up": 888.70001220703125, "invlev_dn": 873.70001220703125, "manhole_up": "manhole_563_generated", "manhole_dn": "manhole_564_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387868.193221996771172, 5859633.330900657922029 ], [ 1387885.535610173596069, 5859679.769344814121723 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 876.20001220703125, "elevtn_dn": 876.20001220703125, "invlev_up": 873.70001220703125, "invlev_dn": 873.70001220703125, "manhole_up": "manhole_564_generated", "manhole_dn": "manhole_565_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387885.535610173596069, 5859679.769344814121723 ], [ 1387902.854485532967374, 5859726.216552678495646 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 876.20001220703125, "elevtn_dn": 898.29998779296875, "invlev_up": 873.70001220703125, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_565_generated", "manhole_dn": "manhole_566_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387902.854485532967374, 5859726.216552678495646 ], [ 1387920.137465380365029, 5859772.67713953461498 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 898.29998779296875, "invlev_up": 895.79998779296875, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_566_generated", "manhole_dn": "manhole_567_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387920.137465380365029, 5859772.67713953461498 ], [ 1387937.420445227529854, 5859819.137726389802992 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 898.29998779296875, "invlev_up": 895.79998779296875, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_567_generated", "manhole_dn": "manhole_568_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387937.420445227529854, 5859819.137726389802992 ], [ 1387948.863530882401392, 5859867.082766367122531 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 918.5, "invlev_up": 895.79998779296875, "invlev_dn": 916.0, "manhole_up": "manhole_568_generated", "manhole_dn": "manhole_569_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387948.863530882401392, 5859867.082766367122531 ], [ 1387950.013254075078294, 5859916.565449987538159 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 918.5, "invlev_up": 916.0, "invlev_dn": 916.0, "manhole_up": "manhole_569_generated", "manhole_dn": "manhole_570_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387950.013254075078294, 5859916.565449987538159 ], [ 1387947.430782878771424, 5859966.047936389222741 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 918.5, "invlev_up": 916.0, "invlev_dn": 916.0, "manhole_up": "manhole_570_generated", "manhole_dn": "manhole_571_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387947.430782878771424, 5859966.047936389222741 ], [ 1387943.997958281077445, 5860015.499966060742736 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 948.60003662109375, "invlev_up": 916.0, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_571_generated", "manhole_dn": "manhole_572_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387943.997958281077445, 5860015.499966060742736 ], [ 1387940.565133683150634, 5860064.951995733194053 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 948.60003662109375, "invlev_up": 946.10003662109375, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_572_generated", "manhole_dn": "manhole_573_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.565133683150634, 5860064.951995733194053 ], [ 1387945.371777657186612, 5860113.959104515612125 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 948.60003662109375, "invlev_up": 946.10003662109375, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_573_generated", "manhole_dn": "manhole_574_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387945.371777657186612, 5860113.959104515612125 ], [ 1387964.117816498270258, 5860159.736532494425774 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 940.5, "invlev_up": 946.10003662109375, "invlev_dn": 938.0, "manhole_up": "manhole_574_generated", "manhole_dn": "manhole_575_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387964.117816498270258, 5860159.736532494425774 ], [ 1387984.093857799191028, 5860205.104420888237655 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 940.5, "invlev_up": 938.0, "invlev_dn": 938.0, "manhole_up": "manhole_575_generated", "manhole_dn": "manhole_576_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387984.093857799191028, 5860205.104420888237655 ], [ 1388004.069899099878967, 5860250.472309282049537 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 940.5, "invlev_up": 938.0, "invlev_dn": 938.0, "manhole_up": "manhole_576_generated", "manhole_dn": "manhole_577_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388004.069899099878967, 5860250.472309282049537 ], [ 1388027.68692572391592, 5860293.896034284494817 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 971.70001220703125, "invlev_up": 938.0, "invlev_dn": 969.20001220703125, "manhole_up": "manhole_577_generated", "manhole_dn": "manhole_578_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388027.68692572391592, 5860293.896034284494817 ], [ 1388060.096315970877185, 5860331.348726416006684 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 971.70001220703125, "elevtn_dn": 935.5, "invlev_up": 969.20001220703125, "invlev_dn": 933.0, "manhole_up": "manhole_578_generated", "manhole_dn": "manhole_579_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388060.096315970877185, 5860331.348726416006684 ], [ 1388092.967688721138984, 5860368.453448176383972 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 935.5, "invlev_up": 933.0, "invlev_dn": 933.0, "manhole_up": "manhole_579_generated", "manhole_dn": "manhole_580_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388092.967688721138984, 5860368.453448176383972 ], [ 1388119.020827289205045, 5860410.510251956991851 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 949.9000244140625, "invlev_up": 933.0, "invlev_dn": 947.4000244140625, "manhole_up": "manhole_580_generated", "manhole_dn": "manhole_581_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388119.020827289205045, 5860410.510251956991851 ], [ 1388143.407622833969072, 5860453.667774203233421 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 949.9000244140625, "elevtn_dn": 924.60003662109375, "invlev_up": 947.4000244140625, "invlev_dn": 922.10003662109375, "manhole_up": "manhole_581_generated", "manhole_dn": "manhole_582_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388143.407622833969072, 5860453.667774203233421 ], [ 1388167.794418378733099, 5860496.82529644947499 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 924.60003662109375, "elevtn_dn": 924.60003662109375, "invlev_up": 922.10003662109375, "invlev_dn": 922.10003662109375, "manhole_up": "manhole_582_generated", "manhole_dn": "manhole_583_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388167.794418378733099, 5860496.82529644947499 ], [ 1388187.41186453984119, 5860542.097804954275489 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 924.60003662109375, "elevtn_dn": 942.4000244140625, "invlev_up": 922.10003662109375, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_583_generated", "manhole_dn": "manhole_584_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388187.41186453984119, 5860542.097804954275489 ], [ 1388193.385166377527639, 5860591.251542154699564 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 942.4000244140625, "invlev_up": 939.9000244140625, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_584_generated", "manhole_dn": "manhole_585_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388193.385166377527639, 5860591.251542154699564 ], [ 1388198.812296225922182, 5860640.524595490656793 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 942.4000244140625, "invlev_up": 939.9000244140625, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_585_generated", "manhole_dn": "manhole_586_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388198.812296225922182, 5860640.524595490656793 ], [ 1388204.239426074549556, 5860689.7976488256827 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 955.0, "invlev_up": 939.9000244140625, "invlev_dn": 952.5, "manhole_up": "manhole_586_generated", "manhole_dn": "manhole_587_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388204.239426074549556, 5860689.7976488256827 ], [ 1388184.484932377934456, 5860730.700381714850664 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E48", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_587_generated", "manhole_dn": "manhole_588_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388184.484932377934456, 5860730.700381714850664 ], [ 1388159.550175313837826, 5860759.392759991809726 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E49", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_588_generated", "manhole_dn": "manhole_589_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388159.550175313837826, 5860759.392759991809726 ], [ 1388171.988544700434431, 5860807.377908634953201 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E50", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_589_generated", "manhole_dn": "manhole_590_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388171.988544700434431, 5860807.377908634953201 ], [ 1388215.013825689908117, 5860825.214942933060229 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E51", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 941.10003662109375, "invlev_up": 952.5, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_590_generated", "manhole_dn": "manhole_591_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388215.013825689908117, 5860825.214942933060229 ], [ 1388264.397385431453586, 5860829.298032846301794 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E52", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_591_generated", "manhole_dn": "manhole_592_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388264.397385431453586, 5860829.298032846301794 ], [ 1388313.062299854354933, 5860837.304878970608115 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E53", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 937.5, "invlev_up": 938.60003662109375, "invlev_dn": 935.0, "manhole_up": "manhole_592_generated", "manhole_dn": "manhole_593_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388313.062299854354933, 5860837.304878970608115 ], [ 1388360.993895401246846, 5860849.948045967146754 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E54", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.5, "elevtn_dn": 937.5, "invlev_up": 935.0, "invlev_dn": 935.0, "manhole_up": "manhole_593_generated", "manhole_dn": "manhole_594_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388360.993895401246846, 5860849.948045967146754 ], [ 1388408.925490947905928, 5860862.591212964616716 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E55", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.5, "elevtn_dn": 937.60003662109375, "invlev_up": 935.0, "invlev_dn": 935.10003662109375, "manhole_up": "manhole_594_generated", "manhole_dn": "manhole_595_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388408.925490947905928, 5860862.591212964616716 ], [ 1388458.220990223577246, 5860866.957201769575477 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E56", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.60003662109375, "elevtn_dn": 937.60003662109375, "invlev_up": 935.10003662109375, "invlev_dn": 935.10003662109375, "manhole_up": "manhole_595_generated", "manhole_dn": "manhole_596_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388458.220990223577246, 5860866.957201769575477 ], [ 1388507.336333080893382, 5860873.218384950421751 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E57", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.60003662109375, "elevtn_dn": 941.20001220703125, "invlev_up": 935.10003662109375, "invlev_dn": 938.70001220703125, "manhole_up": "manhole_596_generated", "manhole_dn": "manhole_597_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388507.336333080893382, 5860873.218384950421751 ], [ 1388556.215695114107803, 5860881.470384138636291 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E58", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.20001220703125, "elevtn_dn": 941.20001220703125, "invlev_up": 938.70001220703125, "invlev_dn": 938.70001220703125, "manhole_up": "manhole_597_generated", "manhole_dn": "manhole_598_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388556.215695114107803, 5860881.470384138636291 ], [ 1388604.556662159739062, 5860892.361969010904431 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E59", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.20001220703125, "elevtn_dn": 943.10003662109375, "invlev_up": 938.70001220703125, "invlev_dn": 940.60003662109375, "manhole_up": "manhole_598_generated", "manhole_dn": "manhole_599_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388604.556662159739062, 5860892.361969010904431 ], [ 1388653.59940263046883, 5860897.15789801068604 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E60", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 943.10003662109375, "elevtn_dn": 943.10003662109375, "invlev_up": 940.60003662109375, "invlev_dn": 940.60003662109375, "manhole_up": "manhole_599_generated", "manhole_dn": "manhole_600_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388653.59940263046883, 5860897.15789801068604 ], [ 1388700.080393208190799, 5860881.090511013753712 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E61", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 943.10003662109375, "elevtn_dn": 946.10003662109375, "invlev_up": 940.60003662109375, "invlev_dn": 943.60003662109375, "manhole_up": "manhole_600_generated", "manhole_dn": "manhole_601_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388700.080393208190799, 5860881.090511013753712 ], [ 1388732.687003659084439, 5860844.794781206175685 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E62", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 946.10003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 943.60003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_601_generated", "manhole_dn": "manhole_602_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388732.687003659084439, 5860844.794781206175685 ], [ 1388755.953327334951609, 5860801.023035684600472 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E63", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 950.10003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_602_generated", "manhole_dn": "manhole_603_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388755.953327334951609, 5860801.023035684600472 ], [ 1388778.23369869007729, 5860756.84024004638195 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E64", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 950.10003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_603_generated", "manhole_dn": "manhole_604_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388778.23369869007729, 5860756.84024004638195 ], [ 1388792.950793598080054, 5860709.504263866692781 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E65", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 953.79998779296875, "invlev_up": 950.10003662109375, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_604_generated", "manhole_dn": "manhole_605_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388792.950793598080054, 5860709.504263866692781 ], [ 1388807.667888506315649, 5860662.168287687934935 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E66", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_605_generated", "manhole_dn": "manhole_606_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388807.667888506315649, 5860662.168287687934935 ], [ 1388819.224422588944435, 5860613.968191100284457 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E67", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 955.70001220703125, "invlev_up": 951.29998779296875, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_606_generated", "manhole_dn": "manhole_607_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388819.224422588944435, 5860613.968191100284457 ], [ 1388830.63825476472266, 5860565.72907877061516 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E68", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_607_generated", "manhole_dn": "manhole_608_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388830.63825476472266, 5860565.72907877061516 ], [ 1388842.052086940500885, 5860517.489966440014541 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E69", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_608_generated", "manhole_dn": "manhole_609_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388842.052086940500885, 5860517.489966440014541 ], [ 1388862.77624000934884, 5860472.578981296159327 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E70", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 964.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_609_generated", "manhole_dn": "manhole_610_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388862.77624000934884, 5860472.578981296159327 ], [ 1388884.529400010826066, 5860428.03588358964771 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E71", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 951.29998779296875, "invlev_up": 962.20001220703125, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_610_generated", "manhole_dn": "manhole_611_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388884.529400010826066, 5860428.03588358964771 ], [ 1388906.282637836178765, 5860383.492823889479041 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E72", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_611_generated", "manhole_dn": "manhole_612_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388906.282637836178765, 5860383.492823889479041 ], [ 1388933.946375871310011, 5860342.419800435192883 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E73", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_612_generated", "manhole_dn": "manhole_613_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388933.946375871310011, 5860342.419800435192883 ], [ 1388962.240715913940221, 5860301.717001453973353 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 752.29998779296875, "invlev_up": 759.10003662109375, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_539_generated", "manhole_dn": "manhole_614_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386871.537448140559718, 5859162.609670763835311 ], [ 1386825.19834817154333, 5859175.156894122250378 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 752.29998779296875, "invlev_up": 749.79998779296875, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_614_generated", "manhole_dn": "manhole_615_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386825.19834817154333, 5859175.156894122250378 ], [ 1386779.333999397465959, 5859189.44842192158103 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 738.0, "invlev_up": 749.79998779296875, "invlev_dn": 735.5, "manhole_up": "manhole_615_generated", "manhole_dn": "manhole_616_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386779.333999397465959, 5859189.44842192158103 ], [ 1386733.445003136992455, 5859203.660136871039867 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 738.0, "invlev_up": 735.5, "invlev_dn": 735.5, "manhole_up": "manhole_616_generated", "manhole_dn": "manhole_617_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386733.445003136992455, 5859203.660136871039867 ], [ 1386687.508546756347641, 5859217.718167688697577 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 763.29998779296875, "invlev_up": 735.5, "invlev_dn": 760.79998779296875, "manhole_up": "manhole_617_generated", "manhole_dn": "manhole_618_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386687.508546756347641, 5859217.718167688697577 ], [ 1386641.572090375469998, 5859231.776198507286608 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 763.29998779296875, "elevtn_dn": 763.29998779296875, "invlev_up": 760.79998779296875, "invlev_dn": 760.79998779296875, "manhole_up": "manhole_618_generated", "manhole_dn": "manhole_619_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386641.572090375469998, 5859231.776198507286608 ], [ 1386595.451642262749374, 5859245.168246414512396 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 763.29998779296875, "elevtn_dn": 754.60003662109375, "invlev_up": 760.79998779296875, "invlev_dn": 752.10003662109375, "manhole_up": "manhole_619_generated", "manhole_dn": "manhole_620_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386595.451642262749374, 5859245.168246414512396 ], [ 1386548.813360751140863, 5859256.685926430858672 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.60003662109375, "elevtn_dn": 754.60003662109375, "invlev_up": 752.10003662109375, "invlev_dn": 752.10003662109375, "manhole_up": "manhole_620_generated", "manhole_dn": "manhole_621_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386548.813360751140863, 5859256.685926430858672 ], [ 1386502.175079239532351, 5859268.203606447204947 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.60003662109375, "elevtn_dn": 742.5, "invlev_up": 752.10003662109375, "invlev_dn": 740.0, "manhole_up": "manhole_621_generated", "manhole_dn": "manhole_622_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386502.175079239532351, 5859268.203606447204947 ], [ 1386455.354356503346935, 5859278.943273726850748 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 742.5, "invlev_up": 740.0, "invlev_dn": 740.0, "manhole_up": "manhole_622_generated", "manhole_dn": "manhole_623_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386455.354356503346935, 5859278.943273726850748 ], [ 1386408.879239794565365, 5859290.671229789964855 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 717.60003662109375, "invlev_up": 740.0, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_623_generated", "manhole_dn": "manhole_624_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386408.879239794565365, 5859290.671229789964855 ], [ 1386364.691368696978316, 5859309.518465746194124 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 717.60003662109375, "invlev_up": 715.10003662109375, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_624_generated", "manhole_dn": "manhole_625_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386364.691368696978316, 5859309.518465746194124 ], [ 1386320.503497599391267, 5859328.365701701492071 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 711.0, "invlev_up": 715.10003662109375, "invlev_dn": 708.5, "manhole_up": "manhole_625_generated", "manhole_dn": "manhole_626_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386320.503497599391267, 5859328.365701701492071 ], [ 1386273.173811787506565, 5859335.36546028777957 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 953.70001220703125, "invlev_up": 948.79998779296875, "invlev_dn": 951.20001220703125, "manhole_up": "manhole_10_generated", "manhole_dn": "manhole_627_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388946.301100668497384, 5860414.883977899327874 ], [ 1388922.246059404918924, 5860458.418739438988268 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.70001220703125, "elevtn_dn": 953.70001220703125, "invlev_up": 951.20001220703125, "invlev_dn": 951.20001220703125, "manhole_up": "manhole_627_generated", "manhole_dn": "manhole_628_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388922.246059404918924, 5860458.418739438988268 ], [ 1388900.295977992936969, 5860503.075897979550064 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 951.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_628_generated", "manhole_dn": "manhole_629_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388900.295977992936969, 5860503.075897979550064 ], [ 1388878.345896581187844, 5860547.733056520111859 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 953.79998779296875, "invlev_up": 953.20001220703125, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_629_generated", "manhole_dn": "manhole_630_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388878.345896581187844, 5860547.733056520111859 ], [ 1388856.887740465346724, 5860592.570927501656115 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_630_generated", "manhole_dn": "manhole_631_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388856.887740465346724, 5860592.570927501656115 ], [ 1388853.076019846601412, 5860641.795407227240503 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_631_generated", "manhole_dn": "manhole_632_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388853.076019846601412, 5860641.795407227240503 ], [ 1388856.119826921960339, 5860691.462329030036926 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 952.5, "invlev_up": 951.29998779296875, "invlev_dn": 950.0, "manhole_up": "manhole_632_generated", "manhole_dn": "manhole_633_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388856.119826921960339, 5860691.462329030036926 ], [ 1388859.163633997086436, 5860741.12925083283335 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.5, "elevtn_dn": 952.5, "invlev_up": 950.0, "invlev_dn": 950.0, "manhole_up": "manhole_633_generated", "manhole_dn": "manhole_634_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388859.163633997086436, 5860741.12925083283335 ], [ 1388862.207441072445363, 5860790.796172635629773 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.5, "elevtn_dn": 945.5, "invlev_up": 950.0, "invlev_dn": 943.0, "manhole_up": "manhole_634_generated", "manhole_dn": "manhole_635_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388862.207441072445363, 5860790.796172635629773 ], [ 1388866.356326055014506, 5860840.344227194786072 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 945.5, "invlev_up": 943.0, "invlev_dn": 943.0, "manhole_up": "manhole_635_generated", "manhole_dn": "manhole_636_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388866.356326055014506, 5860840.344227194786072 ], [ 1388873.944740658160299, 5860889.522310186177492 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 945.5, "invlev_up": 943.0, "invlev_dn": 943.0, "manhole_up": "manhole_636_generated", "manhole_dn": "manhole_637_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388873.944740658160299, 5860889.522310186177492 ], [ 1388883.17427325528115, 5860938.398467163555324 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 937.4000244140625, "invlev_up": 943.0, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_637_generated", "manhole_dn": "manhole_638_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388883.17427325528115, 5860938.398467163555324 ], [ 1388890.216840920504183, 5860987.212368851527572 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 937.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_638_generated", "manhole_dn": "manhole_639_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388890.216840920504183, 5860987.212368851527572 ], [ 1388884.322194910608232, 5861036.62209493201226 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 937.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_639_generated", "manhole_dn": "manhole_640_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388884.322194910608232, 5861036.62209493201226 ], [ 1388878.427548900712281, 5861086.031821011565626 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_640_generated", "manhole_dn": "manhole_641_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388878.427548900712281, 5861086.031821011565626 ], [ 1388872.532902890816331, 5861135.441547092050314 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 927.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_641_generated", "manhole_dn": "manhole_642_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388872.532902890816331, 5861135.441547092050314 ], [ 1388866.63825688092038, 5861184.851273172535002 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 927.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_642_generated", "manhole_dn": "manhole_643_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388866.63825688092038, 5861184.851273172535002 ], [ 1388854.620840607210994, 5861232.489912945777178 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 926.60003662109375, "invlev_up": 927.9000244140625, "invlev_dn": 924.10003662109375, "manhole_up": "manhole_643_generated", "manhole_dn": "manhole_644_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388854.620840607210994, 5861232.489912945777178 ], [ 1388833.22756120422855, 5861277.416469449177384 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 926.60003662109375, "elevtn_dn": 926.60003662109375, "invlev_up": 924.10003662109375, "invlev_dn": 924.10003662109375, "manhole_up": "manhole_644_generated", "manhole_dn": "manhole_645_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388833.22756120422855, 5861277.416469449177384 ], [ 1388811.834281801246107, 5861322.343025953508914 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 926.60003662109375, "elevtn_dn": 931.10003662109375, "invlev_up": 924.10003662109375, "invlev_dn": 928.60003662109375, "manhole_up": "manhole_645_generated", "manhole_dn": "manhole_646_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388811.834281801246107, 5861322.343025953508914 ], [ 1388790.441002398030832, 5861367.26958245690912 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 931.10003662109375, "elevtn_dn": 922.20001220703125, "invlev_up": 928.60003662109375, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_646_generated", "manhole_dn": "manhole_647_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388790.441002398030832, 5861367.26958245690912 ], [ 1388769.047722995048389, 5861412.196138960309327 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 922.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_647_generated", "manhole_dn": "manhole_648_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388769.047722995048389, 5861412.196138960309327 ], [ 1388747.654443592065945, 5861457.122695464640856 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 922.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_648_generated", "manhole_dn": "manhole_649_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388747.654443592065945, 5861457.122695464640856 ], [ 1388725.026126575190574, 5861501.410491958260536 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_649_generated", "manhole_dn": "manhole_650_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388725.026126575190574, 5861501.410491958260536 ], [ 1388700.725248141447082, 5861544.833241644315422 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_650_generated", "manhole_dn": "manhole_651_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388700.725248141447082, 5861544.833241644315422 ], [ 1388676.42436970770359, 5861588.255991329438984 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_651_generated", "manhole_dn": "manhole_652_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388676.42436970770359, 5861588.255991329438984 ], [ 1388632.324464634526521, 5861606.441272142343223 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 898.4000244140625, "invlev_up": 897.70001220703125, "invlev_dn": 895.9000244140625, "manhole_up": "manhole_652_generated", "manhole_dn": "manhole_653_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388632.324464634526521, 5861606.441272142343223 ], [ 1388583.463808472501114, 5861611.105615227483213 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.4000244140625, "elevtn_dn": 898.4000244140625, "invlev_up": 895.9000244140625, "invlev_dn": 895.9000244140625, "manhole_up": "manhole_653_generated", "manhole_dn": "manhole_654_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388583.463808472501114, 5861611.105615227483213 ], [ 1388534.764012826373801, 5861604.222017968073487 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.4000244140625, "elevtn_dn": 903.60003662109375, "invlev_up": 895.9000244140625, "invlev_dn": 901.10003662109375, "manhole_up": "manhole_654_generated", "manhole_dn": "manhole_655_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388534.764012826373801, 5861604.222017968073487 ], [ 1388489.566489090910181, 5861583.40731808822602 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 903.60003662109375, "elevtn_dn": 903.60003662109375, "invlev_up": 901.10003662109375, "invlev_dn": 901.10003662109375, "manhole_up": "manhole_655_generated", "manhole_dn": "manhole_656_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388489.566489090910181, 5861583.40731808822602 ], [ 1388444.204915680922568, 5861563.162508152425289 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 903.60003662109375, "elevtn_dn": 906.4000244140625, "invlev_up": 901.10003662109375, "invlev_dn": 903.9000244140625, "manhole_up": "manhole_656_generated", "manhole_dn": "manhole_657_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388444.204915680922568, 5861563.162508152425289 ], [ 1388394.858231473481283, 5861556.761520680040121 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 906.4000244140625, "elevtn_dn": 906.4000244140625, "invlev_up": 903.9000244140625, "invlev_dn": 903.9000244140625, "manhole_up": "manhole_657_generated", "manhole_dn": "manhole_658_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388394.858231473481283, 5861556.761520680040121 ], [ 1388350.680838279658929, 5861570.408674017526209 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 906.4000244140625, "elevtn_dn": 900.20001220703125, "invlev_up": 903.9000244140625, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_658_generated", "manhole_dn": "manhole_659_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388350.680838279658929, 5861570.408674017526209 ], [ 1388310.581732882419601, 5861599.872713611461222 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_659_generated", "manhole_dn": "manhole_660_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388310.581732882419601, 5861599.872713611461222 ], [ 1388271.039625711739063, 5861629.969603477045894 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 890.0, "invlev_up": 897.70001220703125, "invlev_dn": 887.5, "manhole_up": "manhole_660_generated", "manhole_dn": "manhole_661_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388271.039625711739063, 5861629.969603477045894 ], [ 1388236.722210306907073, 5861666.002683873288333 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 890.0, "invlev_up": 887.5, "invlev_dn": 887.5, "manhole_up": "manhole_661_generated", "manhole_dn": "manhole_662_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388236.722210306907073, 5861666.002683873288333 ], [ 1388202.404794902307913, 5861702.035764269530773 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 890.0, "invlev_up": 887.5, "invlev_dn": 887.5, "manhole_up": "manhole_662_generated", "manhole_dn": "manhole_663_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388202.404794902307913, 5861702.035764269530773 ], [ 1388168.087379497475922, 5861738.068844665773213 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 885.9000244140625, "invlev_up": 887.5, "invlev_dn": 883.4000244140625, "manhole_up": "manhole_663_generated", "manhole_dn": "manhole_664_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388168.087379497475922, 5861738.068844665773213 ], [ 1388133.769964092643932, 5861774.101925062015653 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 885.9000244140625, "elevtn_dn": 874.0, "invlev_up": 883.4000244140625, "invlev_dn": 871.5, "manhole_up": "manhole_664_generated", "manhole_dn": "manhole_665_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388133.769964092643932, 5861774.101925062015653 ], [ 1388099.452548687811941, 5861810.13500545732677 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 874.0, "elevtn_dn": 874.0, "invlev_up": 871.5, "invlev_dn": 871.5, "manhole_up": "manhole_665_generated", "manhole_dn": "manhole_666_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388099.452548687811941, 5861810.13500545732677 ], [ 1388065.135133283212781, 5861846.16808585356921 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 874.0, "elevtn_dn": 862.20001220703125, "invlev_up": 871.5, "invlev_dn": 859.70001220703125, "manhole_up": "manhole_666_generated", "manhole_dn": "manhole_667_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388065.135133283212781, 5861846.16808585356921 ], [ 1388022.995196633273736, 5861866.899685021489859 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 862.20001220703125, "elevtn_dn": 862.20001220703125, "invlev_up": 859.70001220703125, "invlev_dn": 859.70001220703125, "manhole_up": "manhole_667_generated", "manhole_dn": "manhole_668_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388022.995196633273736, 5861866.899685021489859 ], [ 1387973.690499771386385, 5861873.616436487063766 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 862.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 859.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_668_generated", "manhole_dn": "manhole_669_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387973.690499771386385, 5861873.616436487063766 ], [ 1387924.470484273741022, 5861880.90659652557224 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_669_generated", "manhole_dn": "manhole_670_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387924.470484273741022, 5861880.90659652557224 ], [ 1387877.962616891367361, 5861896.157046243548393 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_670_generated", "manhole_dn": "manhole_671_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387877.962616891367361, 5861896.157046243548393 ], [ 1387917.070526217576116, 5861911.915829903446138 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_671_generated", "manhole_dn": "manhole_672_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387917.070526217576116, 5861911.915829903446138 ], [ 1387966.654667611001059, 5861916.096835186704993 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 846.29998779296875, "invlev_up": 856.70001220703125, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_672_generated", "manhole_dn": "manhole_673_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387966.654667611001059, 5861916.096835186704993 ], [ 1388016.318005530629307, 5861919.063731476664543 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 850.10003662109375, "invlev_up": 843.79998779296875, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_673_generated", "manhole_dn": "manhole_674_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388016.318005530629307, 5861919.063731476664543 ], [ 1388066.025120510486886, 5861921.359510923735797 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E48", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 850.10003662109375, "invlev_up": 847.60003662109375, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_674_generated", "manhole_dn": "manhole_675_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388066.025120510486886, 5861921.359510923735797 ], [ 1388115.732235490344465, 5861923.655290370807052 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E49", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 849.0, "invlev_up": 847.60003662109375, "invlev_dn": 846.5, "manhole_up": "manhole_675_generated", "manhole_dn": "manhole_676_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388115.732235490344465, 5861923.655290370807052 ], [ 1388161.130695321131498, 5861931.457672152668238 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E50", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 849.0, "elevtn_dn": 850.10003662109375, "invlev_up": 846.5, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_676_generated", "manhole_dn": "manhole_677_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388161.130695321131498, 5861931.457672152668238 ], [ 1388139.871223766123876, 5861964.082641129381955 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E51", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 850.10003662109375, "invlev_up": 847.60003662109375, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_677_generated", "manhole_dn": "manhole_678_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388139.871223766123876, 5861964.082641129381955 ], [ 1388090.726845995755866, 5861957.769498392008245 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E52", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 846.29998779296875, "invlev_up": 847.60003662109375, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_678_generated", "manhole_dn": "manhole_679_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388090.726845995755866, 5861957.769498392008245 ], [ 1388049.339104855433106, 5861983.736727176234126 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E53", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 846.29998779296875, "invlev_up": 843.79998779296875, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_679_generated", "manhole_dn": "manhole_680_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388049.339104855433106, 5861983.736727176234126 ], [ 1388024.713075590552762, 5862026.975905770435929 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E54", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 846.29998779296875, "invlev_up": 843.79998779296875, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_680_generated", "manhole_dn": "manhole_681_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388024.713075590552762, 5862026.975905770435929 ], [ 1387980.016218039905652, 5862047.702198376879096 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E55", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 793.5, "invlev_up": 843.79998779296875, "invlev_dn": 791.0, "manhole_up": "manhole_681_generated", "manhole_dn": "manhole_682_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387980.016218039905652, 5862047.702198376879096 ], [ 1387931.90673128189519, 5862056.853296543471515 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E56", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.5, "elevtn_dn": 793.5, "invlev_up": 791.0, "invlev_dn": 791.0, "manhole_up": "manhole_682_generated", "manhole_dn": "manhole_683_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387931.90673128189519, 5862056.853296543471515 ], [ 1387882.187313467729837, 5862058.865105460397899 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E57", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.5, "elevtn_dn": 793.20001220703125, "invlev_up": 791.0, "invlev_dn": 790.70001220703125, "manhole_up": "manhole_683_generated", "manhole_dn": "manhole_684_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387882.187313467729837, 5862058.865105460397899 ], [ 1387832.722497318405658, 5862057.3410848621279 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E58", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.20001220703125, "elevtn_dn": 830.29998779296875, "invlev_up": 790.70001220703125, "invlev_dn": 827.79998779296875, "manhole_up": "manhole_684_generated", "manhole_dn": "manhole_685_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387832.722497318405658, 5862057.3410848621279 ], [ 1387783.80423084856011, 5862048.226750630885363 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E59", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.29998779296875, "elevtn_dn": 817.70001220703125, "invlev_up": 827.79998779296875, "invlev_dn": 815.20001220703125, "manhole_up": "manhole_685_generated", "manhole_dn": "manhole_686_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387783.80423084856011, 5862048.226750630885363 ], [ 1387734.885964378714561, 5862039.112416399642825 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E60", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 817.70001220703125, "elevtn_dn": 813.70001220703125, "invlev_up": 815.20001220703125, "invlev_dn": 811.20001220703125, "manhole_up": "manhole_686_generated", "manhole_dn": "manhole_687_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387734.885964378714561, 5862039.112416399642825 ], [ 1387685.967697908869013, 5862029.998082168400288 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E61", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 813.70001220703125, "elevtn_dn": 813.70001220703125, "invlev_up": 811.20001220703125, "invlev_dn": 811.20001220703125, "manhole_up": "manhole_687_generated", "manhole_dn": "manhole_688_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387685.967697908869013, 5862029.998082168400288 ], [ 1387637.036115845199674, 5862020.957140567712486 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E62", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 813.70001220703125, "elevtn_dn": 807.0, "invlev_up": 811.20001220703125, "invlev_dn": 804.5, "manhole_up": "manhole_688_generated", "manhole_dn": "manhole_689_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387637.036115845199674, 5862020.957140567712486 ], [ 1387588.033849656581879, 5862012.305794355459511 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E63", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.0, "elevtn_dn": 807.0, "invlev_up": 804.5, "invlev_dn": 804.5, "manhole_up": "manhole_689_generated", "manhole_dn": "manhole_690_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387588.033849656581879, 5862012.305794355459511 ], [ 1387539.031583468196914, 5862003.654448143206537 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E64", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.0, "elevtn_dn": 793.10003662109375, "invlev_up": 804.5, "invlev_dn": 790.60003662109375, "manhole_up": "manhole_690_generated", "manhole_dn": "manhole_691_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387539.031583468196914, 5862003.654448143206537 ], [ 1387490.029317279579118, 5861995.003101930953562 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E65", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.10003662109375, "elevtn_dn": 793.10003662109375, "invlev_up": 790.60003662109375, "invlev_dn": 790.60003662109375, "manhole_up": "manhole_691_generated", "manhole_dn": "manhole_692_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387490.029317279579118, 5861995.003101930953562 ], [ 1387440.720367865404114, 5861989.908138634636998 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E66", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.10003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 790.60003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_692_generated", "manhole_dn": "manhole_693_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387440.720367865404114, 5861989.908138634636998 ], [ 1387390.960446665296331, 5861990.042768024839461 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E67", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_693_generated", "manhole_dn": "manhole_694_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387390.960446665296331, 5861990.042768024839461 ], [ 1387341.200525465421379, 5861990.177397414110601 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E68", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 749.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 747.10003662109375, "manhole_up": "manhole_694_generated", "manhole_dn": "manhole_695_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387341.200525465421379, 5861990.177397414110601 ], [ 1387291.440604265546426, 5861990.312026804313064 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E69", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 749.60003662109375, "elevtn_dn": 749.60003662109375, "invlev_up": 747.10003662109375, "invlev_dn": 747.10003662109375, "manhole_up": "manhole_695_generated", "manhole_dn": "manhole_696_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387291.440604265546426, 5861990.312026804313064 ], [ 1387246.706285298336297, 5861974.212805554270744 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E70", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 749.60003662109375, "elevtn_dn": 747.0, "invlev_up": 747.10003662109375, "invlev_dn": 744.5, "manhole_up": "manhole_696_generated", "manhole_dn": "manhole_697_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387246.706285298336297, 5861974.212805554270744 ], [ 1387205.725988702848554, 5861945.987228964455426 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E71", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.0, "elevtn_dn": 771.79998779296875, "invlev_up": 744.5, "invlev_dn": 769.29998779296875, "manhole_up": "manhole_697_generated", "manhole_dn": "manhole_698_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387205.725988702848554, 5861945.987228964455426 ], [ 1387164.745692107127979, 5861917.761652374640107 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E72", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.79998779296875, "elevtn_dn": 764.10003662109375, "invlev_up": 769.29998779296875, "invlev_dn": 761.60003662109375, "manhole_up": "manhole_698_generated", "manhole_dn": "manhole_699_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387164.745692107127979, 5861917.761652374640107 ], [ 1387115.569933785125613, 5861911.215812381356955 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E73", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.10003662109375, "elevtn_dn": 764.10003662109375, "invlev_up": 761.60003662109375, "invlev_dn": 761.60003662109375, "manhole_up": "manhole_699_generated", "manhole_dn": "manhole_700_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387115.569933785125613, 5861911.215812381356955 ], [ 1387066.165866439929232, 5861905.273926095105708 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E74", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.10003662109375, "elevtn_dn": 747.70001220703125, "invlev_up": 761.60003662109375, "invlev_dn": 745.20001220703125, "manhole_up": "manhole_700_generated", "manhole_dn": "manhole_701_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387066.165866439929232, 5861905.273926095105708 ], [ 1387016.666836149292067, 5861900.238133460283279 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E75", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.70001220703125, "elevtn_dn": 747.70001220703125, "invlev_up": 745.20001220703125, "invlev_dn": 745.20001220703125, "manhole_up": "manhole_701_generated", "manhole_dn": "manhole_702_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387016.666836149292067, 5861900.238133460283279 ], [ 1386975.698310127714649, 5861874.842493440955877 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E76", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.70001220703125, "elevtn_dn": 739.60003662109375, "invlev_up": 745.20001220703125, "invlev_dn": 737.10003662109375, "manhole_up": "manhole_702_generated", "manhole_dn": "manhole_703_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386975.698310127714649, 5861874.842493440955877 ], [ 1386937.286019780673087, 5861843.21080310922116 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E77", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.60003662109375, "elevtn_dn": 739.60003662109375, "invlev_up": 737.10003662109375, "invlev_dn": 737.10003662109375, "manhole_up": "manhole_703_generated", "manhole_dn": "manhole_704_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386937.286019780673087, 5861843.21080310922116 ], [ 1386898.873729433864355, 5861811.579112778417766 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E78", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.60003662109375, "elevtn_dn": 755.20001220703125, "invlev_up": 737.10003662109375, "invlev_dn": 752.70001220703125, "manhole_up": "manhole_704_generated", "manhole_dn": "manhole_705_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386898.873729433864355, 5861811.579112778417766 ], [ 1386860.461439087055624, 5861779.947422447614372 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E79", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.20001220703125, "elevtn_dn": 745.29998779296875, "invlev_up": 752.70001220703125, "invlev_dn": 742.79998779296875, "manhole_up": "manhole_705_generated", "manhole_dn": "manhole_706_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386860.461439087055624, 5861779.947422447614372 ], [ 1386822.049148740014061, 5861748.315732115879655 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E80", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 745.29998779296875, "elevtn_dn": 745.29998779296875, "invlev_up": 742.79998779296875, "invlev_dn": 742.79998779296875, "manhole_up": "manhole_706_generated", "manhole_dn": "manhole_707_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386822.049148740014061, 5861748.315732115879655 ], [ 1386774.418702265014872, 5861733.958941764198244 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E81", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 745.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 742.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_707_generated", "manhole_dn": "manhole_708_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386774.418702265014872, 5861733.958941764198244 ], [ 1386726.75721522886306, 5861719.660321676172316 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E82", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_708_generated", "manhole_dn": "manhole_709_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386726.75721522886306, 5861719.660321676172316 ], [ 1386681.211287560872734, 5861700.510515534318984 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E83", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 777.9000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_709_generated", "manhole_dn": "manhole_710_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386681.211287560872734, 5861700.510515534318984 ], [ 1386655.081909105414525, 5861659.807657876051962 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E84", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 758.79998779296875, "invlev_up": 775.4000244140625, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_710_generated", "manhole_dn": "manhole_711_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386655.081909105414525, 5861659.807657876051962 ], [ 1386647.41175345890224, 5861610.757949161343277 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E85", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_711_generated", "manhole_dn": "manhole_712_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386647.41175345890224, 5861610.757949161343277 ], [ 1386641.745189253240824, 5861561.363539570011199 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E86", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 732.4000244140625, "invlev_up": 756.29998779296875, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_712_generated", "manhole_dn": "manhole_713_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386641.745189253240824, 5861561.363539570011199 ], [ 1386642.37134926696308, 5861511.607376066967845 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E87", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_713_generated", "manhole_dn": "manhole_714_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386642.37134926696308, 5861511.607376066967845 ], [ 1386642.997509280918166, 5861461.851212563924491 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E88", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_714_generated", "manhole_dn": "manhole_715_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386642.997509280918166, 5861461.851212563924491 ], [ 1386643.623669294640422, 5861412.09504906181246 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E89", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 724.29998779296875, "invlev_up": 729.9000244140625, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_715_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386643.623669294640422, 5861412.09504906181246 ], [ 1386648.271799877518788, 5861347.644815167412162 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_35_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_35", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_35", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_716_generated", "manhole_dn": "manhole_717_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386060.978602184914052, 5859873.390328846871853 ], [ 1386078.54455375042744, 5859857.065600479952991 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_35_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_35", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_35", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_717_generated", "manhole_dn": "manhole_718_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386078.54455375042744, 5859857.065600479952991 ], [ 1386079.86695942771621, 5859885.500408614054322 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_36_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_36", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_36", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_719_generated", "manhole_dn": "manhole_716_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386030.926458492642269, 5859869.881591100245714 ], [ 1386060.978602184914052, 5859873.390328846871853 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_37_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_37", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_37", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_720_generated", "manhole_dn": "manhole_716_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386043.381105761509389, 5859908.11929196305573 ], [ 1386060.978602184914052, 5859873.390328846871853 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_38_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_38", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_718_generated", "manhole_dn": "manhole_721_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386079.86695942771621, 5859885.500408614054322 ], [ 1386081.40363402524963, 5859934.756705570034683 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_38_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_38", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_721_generated", "manhole_dn": "manhole_722_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386081.40363402524963, 5859934.756705570034683 ], [ 1386080.471781946951523, 5859983.948014200665057 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_38_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_38", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 756.5, "invlev_up": 763.79998779296875, "invlev_dn": 754.0, "manhole_up": "manhole_722_generated", "manhole_dn": "manhole_723_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386080.471781946951523, 5859983.948014200665057 ], [ 1386081.101269942475483, 5860033.01989212166518 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_39_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_39", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_718_generated", "manhole_dn": "manhole_724_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386079.86695942771621, 5859885.500408614054322 ], [ 1386051.415038994979113, 5859913.714703594334424 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_39_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_39", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_724_generated", "manhole_dn": "manhole_725_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386051.415038994979113, 5859913.714703594334424 ], [ 1386056.753747603856027, 5859949.43277302198112 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_39_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_39", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_725_generated", "manhole_dn": "manhole_726_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386056.753747603856027, 5859949.43277302198112 ], [ 1386070.153564189793542, 5859990.873222404159606 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_39_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_39", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 756.5, "invlev_up": 763.79998779296875, "invlev_dn": 754.0, "manhole_up": "manhole_726_generated", "manhole_dn": "manhole_723_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386070.153564189793542, 5859990.873222404159606 ], [ 1386081.101269942475483, 5860033.01989212166518 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.5, "elevtn_dn": 756.5, "invlev_up": 754.0, "invlev_dn": 754.0, "manhole_up": "manhole_723_generated", "manhole_dn": "manhole_727_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386081.101269942475483, 5860033.01989212166518 ], [ 1386095.159510504920036, 5860079.476792480796576 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.5, "elevtn_dn": 720.29998779296875, "invlev_up": 754.0, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_727_generated", "manhole_dn": "manhole_728_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386095.159510504920036, 5860079.476792480796576 ], [ 1386119.249574675457552, 5860122.285581497475505 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_728_generated", "manhole_dn": "manhole_729_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386119.249574675457552, 5860122.285581497475505 ], [ 1386143.813145637512207, 5860164.822058788500726 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 732.5, "invlev_up": 717.79998779296875, "invlev_dn": 730.0, "manhole_up": "manhole_729_generated", "manhole_dn": "manhole_730_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386143.813145637512207, 5860164.822058788500726 ], [ 1386168.698389830067754, 5860207.173543182201684 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.5, "elevtn_dn": 732.5, "invlev_up": 730.0, "invlev_dn": 730.0, "manhole_up": "manhole_730_generated", "manhole_dn": "manhole_731_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386168.698389830067754, 5860207.173543182201684 ], [ 1386190.960878706537187, 5860250.914158629253507 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.5, "elevtn_dn": 720.29998779296875, "invlev_up": 730.0, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_731_generated", "manhole_dn": "manhole_732_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386190.960878706537187, 5860250.914158629253507 ], [ 1386212.013376480899751, 5860295.295640649273992 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 729.10003662109375, "invlev_up": 717.79998779296875, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_732_generated", "manhole_dn": "manhole_733_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386212.013376480899751, 5860295.295640649273992 ], [ 1386233.065874255495146, 5860339.677122670225799 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 729.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_733_generated", "manhole_dn": "manhole_734_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386233.065874255495146, 5860339.677122670225799 ], [ 1386254.118372030090541, 5860384.058604690246284 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 729.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_734_generated", "manhole_dn": "manhole_735_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386254.118372030090541, 5860384.058604690246284 ], [ 1386270.265550139825791, 5860430.368606903590262 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 746.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 743.60003662109375, "manhole_up": "manhole_735_generated", "manhole_dn": "manhole_736_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386270.265550139825791, 5860430.368606903590262 ], [ 1386284.690116602927446, 5860477.310510716401041 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 746.10003662109375, "elevtn_dn": 746.10003662109375, "invlev_up": 743.60003662109375, "invlev_dn": 743.60003662109375, "manhole_up": "manhole_736_generated", "manhole_dn": "manhole_737_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386284.690116602927446, 5860477.310510716401041 ], [ 1386295.943752367515117, 5860525.125563691370189 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 746.10003662109375, "elevtn_dn": 720.29998779296875, "invlev_up": 743.60003662109375, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_737_generated", "manhole_dn": "manhole_738_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386295.943752367515117, 5860525.125563691370189 ], [ 1386307.197388132335618, 5860572.940616665408015 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_738_generated", "manhole_dn": "manhole_739_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386307.197388132335618, 5860572.940616665408015 ], [ 1386318.451023896923289, 5860620.755669640377164 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_739_generated", "manhole_dn": "manhole_740_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386318.451023896923289, 5860620.755669640377164 ], [ 1386329.704659661510959, 5860668.57072261441499 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 737.60003662109375, "invlev_up": 717.79998779296875, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_740_generated", "manhole_dn": "manhole_741_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386329.704659661510959, 5860668.57072261441499 ], [ 1386340.95829542633146, 5860716.385775589384139 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 737.60003662109375, "invlev_up": 735.10003662109375, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_741_generated", "manhole_dn": "manhole_742_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386340.95829542633146, 5860716.385775589384139 ], [ 1386352.211931190919131, 5860764.200828563421965 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 737.60003662109375, "invlev_up": 735.10003662109375, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_742_generated", "manhole_dn": "manhole_743_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386352.211931190919131, 5860764.200828563421965 ], [ 1386365.771370212780312, 5860811.365820310078561 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 744.5, "invlev_up": 735.10003662109375, "invlev_dn": 742.0, "manhole_up": "manhole_743_generated", "manhole_dn": "manhole_744_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386365.771370212780312, 5860811.365820310078561 ], [ 1386381.150273493025452, 5860858.017861452884972 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 744.5, "elevtn_dn": 724.29998779296875, "invlev_up": 742.0, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_744_generated", "manhole_dn": "manhole_745_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386381.150273493025452, 5860858.017861452884972 ], [ 1386398.399082327727228, 5860903.951519219204783 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_745_generated", "manhole_dn": "manhole_746_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386398.399082327727228, 5860903.951519219204783 ], [ 1386418.211523674428463, 5860948.90027645137161 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_746_generated", "manhole_dn": "manhole_747_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386418.211523674428463, 5860948.90027645137161 ], [ 1386441.67837643600069, 5860992.033180211670697 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_747_generated", "manhole_dn": "manhole_748_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386441.67837643600069, 5860992.033180211670697 ], [ 1386465.536530936835334, 5861034.971648660488427 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.9000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 722.4000244140625, "manhole_up": "manhole_748_generated", "manhole_dn": "manhole_749_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386465.536530936835334, 5861034.971648660488427 ], [ 1386489.394685437437147, 5861077.910117109306157 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.9000244140625, "elevtn_dn": 724.29998779296875, "invlev_up": 722.4000244140625, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_749_generated", "manhole_dn": "manhole_750_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386489.394685437437147, 5861077.910117109306157 ], [ 1386513.252839938271791, 5861120.848585557192564 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_750_generated", "manhole_dn": "manhole_751_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386513.252839938271791, 5861120.848585557192564 ], [ 1386537.110994438873604, 5861163.787054006010294 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_751_generated", "manhole_dn": "manhole_752_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386537.110994438873604, 5861163.787054006010294 ], [ 1386560.969148939708248, 5861206.725522454828024 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_752_generated", "manhole_dn": "manhole_753_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386560.969148939708248, 5861206.725522454828024 ], [ 1386584.827303440310061, 5861249.663990902714431 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_753_generated", "manhole_dn": "manhole_754_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386584.827303440310061, 5861249.663990902714431 ], [ 1386607.696082097478211, 5861293.105181481689215 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_754_generated", "manhole_dn": "manhole_755_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386607.696082097478211, 5861293.105181481689215 ], [ 1386626.999141034670174, 5861338.164890616200864 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 732.4000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_755_generated", "manhole_dn": "manhole_756_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386626.999141034670174, 5861338.164890616200864 ], [ 1386632.635544582502916, 5861386.242180755361915 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_756_generated", "manhole_dn": "manhole_757_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386632.635544582502916, 5861386.242180755361915 ], [ 1386628.332881111185998, 5861435.174896763637662 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_757_generated", "manhole_dn": "manhole_758_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386628.332881111185998, 5861435.174896763637662 ], [ 1386624.030217639869079, 5861484.107612771913409 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 758.79998779296875, "invlev_up": 729.9000244140625, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_758_generated", "manhole_dn": "manhole_759_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386624.030217639869079, 5861484.107612771913409 ], [ 1386619.72755416855216, 5861533.040328779257834 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_759_generated", "manhole_dn": "manhole_760_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386619.72755416855216, 5861533.040328779257834 ], [ 1386620.396809899713844, 5861581.843449912965298 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_760_generated", "manhole_dn": "manhole_761_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386620.396809899713844, 5861581.843449912965298 ], [ 1386627.242796876933426, 5861630.485572309233248 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 777.9000244140625, "invlev_up": 756.29998779296875, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_761_generated", "manhole_dn": "manhole_762_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386627.242796876933426, 5861630.485572309233248 ], [ 1386633.497009602142498, 5861679.177458625286818 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 777.9000244140625, "invlev_up": 775.4000244140625, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_762_generated", "manhole_dn": "manhole_763_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386633.497009602142498, 5861679.177458625286818 ], [ 1386633.587326586712152, 5861728.232037586160004 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 777.9000244140625, "invlev_up": 775.4000244140625, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_763_generated", "manhole_dn": "manhole_764_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386633.587326586712152, 5861728.232037586160004 ], [ 1386628.569951781770214, 5861777.096641942858696 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 787.0, "invlev_up": 775.4000244140625, "invlev_dn": 784.5, "manhole_up": "manhole_764_generated", "manhole_dn": "manhole_765_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386628.569951781770214, 5861777.096641942858696 ], [ 1386623.552576976828277, 5861825.961246299557388 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.0, "elevtn_dn": 787.0, "invlev_up": 784.5, "invlev_dn": 784.5, "manhole_up": "manhole_765_generated", "manhole_dn": "manhole_766_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386623.552576976828277, 5861825.961246299557388 ], [ 1386622.452884682221338, 5861875.377415779046714 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.0, "elevtn_dn": 768.0, "invlev_up": 784.5, "invlev_dn": 765.5, "manhole_up": "manhole_766_generated", "manhole_dn": "manhole_767_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386622.452884682221338, 5861875.377415779046714 ], [ 1386630.050831846194342, 5861924.208797036670148 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_767_generated", "manhole_dn": "manhole_768_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386630.050831846194342, 5861924.208797036670148 ], [ 1386645.112437101313844, 5861971.295391816645861 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_768_generated", "manhole_dn": "manhole_769_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386645.112437101313844, 5861971.295391816645861 ], [ 1386663.826805545249954, 5862017.116109635680914 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 729.0, "invlev_up": 765.5, "invlev_dn": 726.5, "manhole_up": "manhole_769_generated", "manhole_dn": "manhole_770_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386663.826805545249954, 5862017.116109635680914 ], [ 1386682.541173989186063, 5862062.93682745564729 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 729.0, "invlev_up": 726.5, "invlev_dn": 726.5, "manhole_up": "manhole_770_generated", "manhole_dn": "manhole_771_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386682.541173989186063, 5862062.93682745564729 ], [ 1386700.357504795538262, 5862109.113540357910097 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 729.0, "invlev_up": 726.5, "invlev_dn": 726.5, "manhole_up": "manhole_771_generated", "manhole_dn": "manhole_772_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386700.357504795538262, 5862109.113540357910097 ], [ 1386718.120609947945923, 5862155.311352676711977 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 724.29998779296875, "invlev_up": 726.5, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_772_generated", "manhole_dn": "manhole_773_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386718.120609947945923, 5862155.311352676711977 ], [ 1386735.883715100120753, 5862201.509164996445179 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_773_generated", "manhole_dn": "manhole_774_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386735.883715100120753, 5862201.509164996445179 ], [ 1386757.522535112220794, 5862245.993861058726907 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_774_generated", "manhole_dn": "manhole_775_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386757.522535112220794, 5862245.993861058726907 ], [ 1386779.73098383564502, 5862290.226773838512599 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_775_generated", "manhole_dn": "manhole_776_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386779.73098383564502, 5862290.226773838512599 ], [ 1386802.545179207576439, 5862334.095372994430363 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_776_generated", "manhole_dn": "manhole_777_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386802.545179207576439, 5862334.095372994430363 ], [ 1386831.207993831252679, 5862374.446442689746618 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 737.70001220703125, "invlev_up": 721.79998779296875, "invlev_dn": 735.20001220703125, "manhole_up": "manhole_777_generated", "manhole_dn": "manhole_778_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386831.207993831252679, 5862374.446442689746618 ], [ 1386859.988485741894692, 5862414.708453865721822 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.70001220703125, "elevtn_dn": 737.70001220703125, "invlev_up": 735.20001220703125, "invlev_dn": 735.20001220703125, "manhole_up": "manhole_778_generated", "manhole_dn": "manhole_779_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386859.988485741894692, 5862414.708453865721822 ], [ 1386891.035651177866384, 5862453.255039785988629 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.70001220703125, "elevtn_dn": 743.9000244140625, "invlev_up": 735.20001220703125, "invlev_dn": 741.4000244140625, "manhole_up": "manhole_779_generated", "manhole_dn": "manhole_780_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386891.035651177866384, 5862453.255039785988629 ], [ 1386922.082816614070907, 5862491.801625707186759 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 743.9000244140625, "elevtn_dn": 756.0, "invlev_up": 741.4000244140625, "invlev_dn": 753.5, "manhole_up": "manhole_780_generated", "manhole_dn": "manhole_781_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386922.082816614070907, 5862491.801625707186759 ], [ 1386953.12998205027543, 5862530.348211627453566 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.0, "elevtn_dn": 756.0, "invlev_up": 753.5, "invlev_dn": 753.5, "manhole_up": "manhole_781_generated", "manhole_dn": "manhole_782_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386953.12998205027543, 5862530.348211627453566 ], [ 1386984.177147486479953, 5862568.894797547720373 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.0, "elevtn_dn": 761.4000244140625, "invlev_up": 753.5, "invlev_dn": 758.9000244140625, "manhole_up": "manhole_782_generated", "manhole_dn": "manhole_783_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386984.177147486479953, 5862568.894797547720373 ], [ 1387010.83190148579888, 5862610.297833287157118 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.4000244140625, "elevtn_dn": 761.4000244140625, "invlev_up": 758.9000244140625, "invlev_dn": 758.9000244140625, "manhole_up": "manhole_783_generated", "manhole_dn": "manhole_784_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387010.83190148579888, 5862610.297833287157118 ], [ 1387033.474099110113457, 5862654.310293504968286 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.4000244140625, "elevtn_dn": 770.5, "invlev_up": 758.9000244140625, "invlev_dn": 768.0, "manhole_up": "manhole_784_generated", "manhole_dn": "manhole_785_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387033.474099110113457, 5862654.310293504968286 ], [ 1387056.116296734428033, 5862698.322753723710775 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.5, "elevtn_dn": 765.29998779296875, "invlev_up": 768.0, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_785_generated", "manhole_dn": "manhole_786_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387056.116296734428033, 5862698.322753723710775 ], [ 1387078.75849435874261, 5862742.335213942453265 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 765.29998779296875, "invlev_up": 762.79998779296875, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_786_generated", "manhole_dn": "manhole_787_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387078.75849435874261, 5862742.335213942453265 ], [ 1387101.400691983057186, 5862786.347674161195755 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 765.29998779296875, "invlev_up": 762.79998779296875, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_787_generated", "manhole_dn": "manhole_788_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387101.400691983057186, 5862786.347674161195755 ], [ 1387124.783531384309754, 5862829.966971693560481 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 764.20001220703125, "invlev_up": 762.79998779296875, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_788_generated", "manhole_dn": "manhole_789_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387124.783531384309754, 5862829.966971693560481 ], [ 1387148.551342260092497, 5862873.381910757161677 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 764.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_789_generated", "manhole_dn": "manhole_790_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387148.551342260092497, 5862873.381910757161677 ], [ 1387176.029596295906231, 5862914.516764627769589 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 764.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_790_generated", "manhole_dn": "manhole_791_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387176.029596295906231, 5862914.516764627769589 ], [ 1387204.050833505578339, 5862955.315435893833637 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 769.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 766.70001220703125, "manhole_up": "manhole_791_generated", "manhole_dn": "manhole_792_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387204.050833505578339, 5862955.315435893833637 ], [ 1387233.152246462181211, 5862995.351338926702738 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.20001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 766.70001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_792_generated", "manhole_dn": "manhole_793_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387233.152246462181211, 5862995.351338926702738 ], [ 1387262.253659419016913, 5863035.387241959571838 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 770.20001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_793_generated", "manhole_dn": "manhole_794_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387262.253659419016913, 5863035.387241959571838 ], [ 1387289.177211825968698, 5863076.714860137552023 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 770.20001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_794_generated", "manhole_dn": "manhole_795_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387289.177211825968698, 5863076.714860137552023 ], [ 1387304.666786204557866, 5863123.392671256326139 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 762.0, "invlev_up": 770.20001220703125, "invlev_dn": 759.5, "manhole_up": "manhole_795_generated", "manhole_dn": "manhole_796_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387304.666786204557866, 5863123.392671256326139 ], [ 1387314.520281337434426, 5863171.895173518918455 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 777.10003662109375, "invlev_up": 759.5, "invlev_dn": 774.60003662109375, "manhole_up": "manhole_796_generated", "manhole_dn": "manhole_797_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387314.520281337434426, 5863171.895173518918455 ], [ 1387324.142220750683919, 5863220.446013364940882 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.10003662109375, "elevtn_dn": 780.4000244140625, "invlev_up": 774.60003662109375, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_797_generated", "manhole_dn": "manhole_798_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387324.142220750683919, 5863220.446013364940882 ], [ 1387333.764160163700581, 5863268.996853210031986 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 780.4000244140625, "invlev_up": 777.9000244140625, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_798_generated", "manhole_dn": "manhole_799_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387333.764160163700581, 5863268.996853210031986 ], [ 1387343.386099576717243, 5863317.547693055123091 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 780.4000244140625, "invlev_up": 777.9000244140625, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_799_generated", "manhole_dn": "manhole_800_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387343.386099576717243, 5863317.547693055123091 ], [ 1387353.008038989733905, 5863366.098532900214195 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 762.0, "invlev_up": 777.9000244140625, "invlev_dn": 759.5, "manhole_up": "manhole_800_generated", "manhole_dn": "manhole_801_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387353.008038989733905, 5863366.098532900214195 ], [ 1387364.066297837067395, 5863414.311534740030766 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_801_generated", "manhole_dn": "manhole_802_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387364.066297837067395, 5863414.311534740030766 ], [ 1387381.839409928303212, 5863460.427046488039196 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_802_generated", "manhole_dn": "manhole_803_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387381.839409928303212, 5863460.427046488039196 ], [ 1387403.429578960640356, 5863504.96100580971688 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_803_generated", "manhole_dn": "manhole_804_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387403.429578960640356, 5863504.96100580971688 ], [ 1387425.140452897874638, 5863549.440256260335445 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_804_generated", "manhole_dn": "manhole_805_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387425.140452897874638, 5863549.440256260335445 ], [ 1387446.851326835108921, 5863593.91950671095401 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_805_generated", "manhole_dn": "manhole_806_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387446.851326835108921, 5863593.91950671095401 ], [ 1387467.528695637593046, 5863638.888379830867052 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 774.5, "invlev_up": 759.5, "invlev_dn": 772.0, "manhole_up": "manhole_806_generated", "manhole_dn": "manhole_807_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387467.528695637593046, 5863638.888379830867052 ], [ 1387488.196078018052503, 5863683.861984014511108 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.5, "elevtn_dn": 762.0, "invlev_up": 772.0, "invlev_dn": 759.5, "manhole_up": "manhole_807_generated", "manhole_dn": "manhole_808_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387488.196078018052503, 5863683.861984014511108 ], [ 1387508.863468252588063, 5863728.835584589280188 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_808_generated", "manhole_dn": "manhole_809_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387508.863468252588063, 5863728.835584589280188 ], [ 1387529.53130904212594, 5863773.808978110551834 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_809_generated", "manhole_dn": "manhole_810_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387529.53130904212594, 5863773.808978110551834 ], [ 1387553.168002701364458, 5863817.17347530182451 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_810_generated", "manhole_dn": "manhole_811_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387553.168002701364458, 5863817.17347530182451 ], [ 1387579.562712850514799, 5863859.043333718553185 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 777.0, "invlev_up": 759.5, "invlev_dn": 774.5, "manhole_up": "manhole_811_generated", "manhole_dn": "manhole_812_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387579.562712850514799, 5863859.043333718553185 ], [ 1387605.957422999665141, 5863900.913192136213183 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.0, "elevtn_dn": 762.0, "invlev_up": 774.5, "invlev_dn": 759.5, "manhole_up": "manhole_812_generated", "manhole_dn": "manhole_813_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387605.957422999665141, 5863900.913192136213183 ], [ 1387632.352133149048313, 5863942.783050553873181 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E48", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_813_generated", "manhole_dn": "manhole_814_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387632.352133149048313, 5863942.783050553873181 ], [ 1387658.746843298198655, 5863984.652908970601857 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E49", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_814_generated", "manhole_dn": "manhole_815_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387658.746843298198655, 5863984.652908970601857 ], [ 1387685.893106181640178, 5864026.029537551105022 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E50", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_815_generated", "manhole_dn": "manhole_816_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387685.893106181640178, 5864026.029537551105022 ], [ 1387711.231136992340907, 5864068.42725711222738 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E51", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_816_generated", "manhole_dn": "manhole_817_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387711.231136992340907, 5864068.42725711222738 ], [ 1387731.020947323646396, 5864113.414904261007905 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E52", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_817_generated", "manhole_dn": "manhole_818_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387731.020947323646396, 5864113.414904261007905 ], [ 1387737.361907477490604, 5864162.342261835932732 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E53", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_818_generated", "manhole_dn": "manhole_819_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387737.361907477490604, 5864162.342261835932732 ], [ 1387732.727565656881779, 5864211.475179814733565 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E54", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_819_generated", "manhole_dn": "manhole_820_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387732.727565656881779, 5864211.475179814733565 ], [ 1387717.67884943424724, 5864258.627082298509777 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E55", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_820_generated", "manhole_dn": "manhole_821_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387717.67884943424724, 5864258.627082298509777 ], [ 1387709.67210421175696, 5864307.23127611912787 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E56", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 768.0, "invlev_up": 759.5, "invlev_dn": 765.5, "manhole_up": "manhole_821_generated", "manhole_dn": "manhole_822_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387709.67210421175696, 5864307.23127611912787 ], [ 1387707.11288084089756, 5864356.66017600055784 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E57", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_822_generated", "manhole_dn": "manhole_823_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387707.11288084089756, 5864356.66017600055784 ], [ 1387709.591797993984073, 5864406.012949175201356 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E58", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_823_generated", "manhole_dn": "manhole_824_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387709.591797993984073, 5864406.012949175201356 ], [ 1387713.643261310644448, 5864455.341961052268744 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E59", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 777.20001220703125, "invlev_up": 765.5, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_824_generated", "manhole_dn": "manhole_825_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387713.643261310644448, 5864455.341961052268744 ], [ 1387715.877521668095142, 5864504.642317942343652 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E60", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 774.70001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_825_generated", "manhole_dn": "manhole_826_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387715.877521668095142, 5864504.642317942343652 ], [ 1387708.68023270717822, 5864553.426558391191065 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E61", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 774.70001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_826_generated", "manhole_dn": "manhole_827_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387708.68023270717822, 5864553.426558391191065 ], [ 1387690.790250770282, 5864599.575386263430119 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E62", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 810.60003662109375, "invlev_up": 774.70001220703125, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_827_generated", "manhole_dn": "manhole_828_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387690.790250770282, 5864599.575386263430119 ], [ 1387672.900268833618611, 5864645.724214136600494 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E63", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 810.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_828_generated", "manhole_dn": "manhole_829_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387672.900268833618611, 5864645.724214136600494 ], [ 1387659.931900478899479, 5864692.98388583958149 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E64", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 810.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_829_generated", "manhole_dn": "manhole_830_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387659.931900478899479, 5864692.98388583958149 ], [ 1387659.223570322152227, 5864742.029465307481587 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E65", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_830_generated", "manhole_dn": "manhole_831_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387659.223570322152227, 5864742.029465307481587 ], [ 1387675.926896508783102, 5864788.273513910360634 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E66", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 774.10003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 771.60003662109375, "manhole_up": "manhole_831_generated", "manhole_dn": "manhole_832_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387675.926896508783102, 5864788.273513910360634 ], [ 1387702.296291569946334, 5864830.159320239908993 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E67", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.10003662109375, "elevtn_dn": 774.10003662109375, "invlev_up": 771.60003662109375, "invlev_dn": 771.60003662109375, "manhole_up": "manhole_832_generated", "manhole_dn": "manhole_833_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387702.296291569946334, 5864830.159320239908993 ], [ 1387728.665686630876735, 5864872.045126569457352 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E68", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.10003662109375, "elevtn_dn": 782.5, "invlev_up": 771.60003662109375, "invlev_dn": 780.0, "manhole_up": "manhole_833_generated", "manhole_dn": "manhole_834_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387728.665686630876735, 5864872.045126569457352 ], [ 1387751.608185108983889, 5864915.528788692317903 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E69", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 782.5, "invlev_up": 780.0, "invlev_dn": 780.0, "manhole_up": "manhole_834_generated", "manhole_dn": "manhole_835_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387751.608185108983889, 5864915.528788692317903 ], [ 1387766.741664502769709, 5864962.653554677963257 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E70", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 782.5, "invlev_up": 780.0, "invlev_dn": 780.0, "manhole_up": "manhole_835_generated", "manhole_dn": "manhole_836_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387766.741664502769709, 5864962.653554677963257 ], [ 1387778.99191950308159, 5865010.246724016033113 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E71", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 820.20001220703125, "invlev_up": 780.0, "invlev_dn": 817.70001220703125, "manhole_up": "manhole_836_generated", "manhole_dn": "manhole_837_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387778.99191950308159, 5865010.246724016033113 ], [ 1387779.554608268430457, 5865059.738633952103555 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E72", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.20001220703125, "elevtn_dn": 820.20001220703125, "invlev_up": 817.70001220703125, "invlev_dn": 817.70001220703125, "manhole_up": "manhole_837_generated", "manhole_dn": "manhole_838_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387779.554608268430457, 5865059.738633952103555 ], [ 1387780.117297033779323, 5865109.230543887242675 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E73", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.20001220703125, "elevtn_dn": 834.60003662109375, "invlev_up": 817.70001220703125, "invlev_dn": 832.10003662109375, "manhole_up": "manhole_838_generated", "manhole_dn": "manhole_839_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387780.117297033779323, 5865109.230543887242675 ], [ 1387782.917817069217563, 5865158.566991245374084 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E74", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 834.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 832.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_839_generated", "manhole_dn": "manhole_840_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387782.917817069217563, 5865158.566991245374084 ], [ 1387789.203931836877018, 5865207.661293652839959 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E75", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_840_generated", "manhole_dn": "manhole_841_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387789.203931836877018, 5865207.661293652839959 ], [ 1387795.490046604769304, 5865256.755596060305834 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E76", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_841_generated", "manhole_dn": "manhole_842_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387795.490046604769304, 5865256.755596060305834 ], [ 1387804.549934879876673, 5865305.332479531876743 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E77", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 809.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_842_generated", "manhole_dn": "manhole_843_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387804.549934879876673, 5865305.332479531876743 ], [ 1387816.386747075244784, 5865353.391356389038265 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E78", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 809.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_843_generated", "manhole_dn": "manhole_844_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387816.386747075244784, 5865353.391356389038265 ], [ 1387828.223559270845726, 5865401.450233246199787 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E79", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 802.5, "invlev_up": 809.10003662109375, "invlev_dn": 800.0, "manhole_up": "manhole_844_generated", "manhole_dn": "manhole_845_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387828.223559270845726, 5865401.450233246199787 ], [ 1387842.96627543354407, 5865448.679594250395894 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E80", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 802.5, "invlev_up": 800.0, "invlev_dn": 800.0, "manhole_up": "manhole_845_generated", "manhole_dn": "manhole_846_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387842.96627543354407, 5865448.679594250395894 ], [ 1387858.283513206522912, 5865495.744953005574644 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E81", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 802.5, "invlev_up": 800.0, "invlev_dn": 800.0, "manhole_up": "manhole_846_generated", "manhole_dn": "manhole_847_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387858.283513206522912, 5865495.744953005574644 ], [ 1387872.788357679266483, 5865543.026506381109357 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E82", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 778.20001220703125, "invlev_up": 800.0, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_847_generated", "manhole_dn": "manhole_848_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387872.788357679266483, 5865543.026506381109357 ], [ 1387882.890574953285977, 5865591.479689701460302 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E83", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_848_generated", "manhole_dn": "manhole_849_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387882.890574953285977, 5865591.479689701460302 ], [ 1387892.992792227305472, 5865639.932873022742569 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E84", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_849_generated", "manhole_dn": "manhole_850_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387892.992792227305472, 5865639.932873022742569 ], [ 1387903.095009501324967, 5865688.386056343093514 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E85", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_850_generated", "manhole_dn": "manhole_851_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387903.095009501324967, 5865688.386056343093514 ], [ 1387913.197226775344461, 5865736.839239663444459 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 830.9000244140625, "invlev_up": 828.4000244140625, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_852_generated", "manhole_dn": "manhole_853_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387767.438602478476241, 5866395.894650792703032 ], [ 1387758.181959156645462, 5866444.388786932453513 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 830.9000244140625, "invlev_up": 828.4000244140625, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_853_generated", "manhole_dn": "manhole_854_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387758.181959156645462, 5866444.388786932453513 ], [ 1387748.925315835047513, 5866492.882923071272671 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 816.5, "invlev_up": 828.4000244140625, "invlev_dn": 814.0, "manhole_up": "manhole_854_generated", "manhole_dn": "manhole_855_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387748.925315835047513, 5866492.882923071272671 ], [ 1387739.668672513216734, 5866541.377059211023152 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.5, "elevtn_dn": 816.5, "invlev_up": 814.0, "invlev_dn": 814.0, "manhole_up": "manhole_855_generated", "manhole_dn": "manhole_856_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387739.668672513216734, 5866541.377059211023152 ], [ 1387730.412029191618785, 5866589.87119534984231 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.5, "elevtn_dn": 816.10003662109375, "invlev_up": 814.0, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_856_generated", "manhole_dn": "manhole_857_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387730.412029191618785, 5866589.87119534984231 ], [ 1387721.155385869788006, 5866638.365331489592791 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 816.10003662109375, "invlev_up": 813.60003662109375, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_857_generated", "manhole_dn": "manhole_858_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387721.155385869788006, 5866638.365331489592791 ], [ 1387711.868742506252602, 5866686.853722332976758 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 816.10003662109375, "invlev_up": 813.60003662109375, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_858_generated", "manhole_dn": "manhole_859_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387711.868742506252602, 5866686.853722332976758 ], [ 1387702.553355348296463, 5866735.336608462966979 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 802.4000244140625, "invlev_up": 813.60003662109375, "invlev_dn": 799.9000244140625, "manhole_up": "manhole_859_generated", "manhole_dn": "manhole_860_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387702.553355348296463, 5866735.336608462966979 ], [ 1387692.161796326050535, 5866783.420620376244187 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_43_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_43", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_43", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_861_generated", "manhole_dn": "manhole_862_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387809.534624515566975, 5866309.639251782558858 ], [ 1387788.486613497138023, 5866352.766951287165284 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_43_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_43", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_43", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 830.9000244140625, "invlev_up": 803.70001220703125, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_862_generated", "manhole_dn": "manhole_852_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387788.486613497138023, 5866352.766951287165284 ], [ 1387767.438602478476241, 5866395.894650792703032 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 840.10003662109375, "invlev_up": 828.4000244140625, "invlev_dn": 837.60003662109375, "manhole_up": "manhole_852_generated", "manhole_dn": "manhole_863_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387767.438602478476241, 5866395.894650792703032 ], [ 1387774.73306847945787, 5866351.644692087545991 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 840.10003662109375, "elevtn_dn": 806.20001220703125, "invlev_up": 837.60003662109375, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_863_generated", "manhole_dn": "manhole_864_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387774.73306847945787, 5866351.644692087545991 ], [ 1387787.219046234386042, 5866308.756401930935681 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_864_generated", "manhole_dn": "manhole_865_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387787.219046234386042, 5866308.756401930935681 ], [ 1387802.581935805035755, 5866266.622689731419086 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_865_generated", "manhole_dn": "manhole_866_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387802.581935805035755, 5866266.622689731419086 ], [ 1387818.989883717847988, 5866224.886323318816721 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_866_generated", "manhole_dn": "manhole_867_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387818.989883717847988, 5866224.886323318816721 ], [ 1387838.767447788733989, 5866184.784887914545834 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_867_generated", "manhole_dn": "manhole_868_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387838.767447788733989, 5866184.784887914545834 ], [ 1387862.375427621416748, 5866146.679679537191987 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 803.9000244140625, "invlev_up": 825.20001220703125, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_868_generated", "manhole_dn": "manhole_869_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387862.375427621416748, 5866146.679679537191987 ], [ 1387890.316308293025941, 5866111.904927220195532 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_869_generated", "manhole_dn": "manhole_870_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387890.316308293025941, 5866111.904927220195532 ], [ 1387932.086585889104754, 5866099.149365295656025 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_45_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_45", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_871_generated", "manhole_dn": "manhole_872_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387931.614702571649104, 5866170.542120457626879 ], [ 1387899.497387683717534, 5866203.806988564319909 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_45_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_45", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 806.20001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_872_generated", "manhole_dn": "manhole_873_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387899.497387683717534, 5866203.806988564319909 ], [ 1387869.509799961000681, 5866239.084409636445343 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_45_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_45", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_873_generated", "manhole_dn": "manhole_874_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387869.509799961000681, 5866239.084409636445343 ], [ 1387839.522212238283828, 5866274.361830709502101 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_45_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_45", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_874_generated", "manhole_dn": "manhole_861_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387839.522212238283828, 5866274.361830709502101 ], [ 1387809.534624515566975, 5866309.639251782558858 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_46_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_870_generated", "manhole_dn": "manhole_875_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387932.086585889104754, 5866099.149365295656025 ], [ 1387908.367353544337675, 5866141.903963415883482 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_46_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_875_generated", "manhole_dn": "manhole_876_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387908.367353544337675, 5866141.903963415883482 ], [ 1387876.955022902460769, 5866179.987773489207029 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_46_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 827.70001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_876_generated", "manhole_dn": "manhole_877_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387876.955022902460769, 5866179.987773489207029 ], [ 1387847.458594153402373, 5866219.470102892257273 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_46_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_877_generated", "manhole_dn": "manhole_878_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387847.458594153402373, 5866219.470102892257273 ], [ 1387823.639855962945148, 5866262.662997540086508 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_46_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_878_generated", "manhole_dn": "manhole_861_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387823.639855962945148, 5866262.662997540086508 ], [ 1387809.534624515566975, 5866309.639251782558858 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_47_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_879_generated", "manhole_dn": "manhole_880_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.443674022099003, 5865845.093254727311432 ], [ 1387943.318034203490242, 5865887.628139751963317 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_47_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_880_generated", "manhole_dn": "manhole_881_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387943.318034203490242, 5865887.628139751963317 ], [ 1387946.009428307646886, 5865930.175072746351361 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_47_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 816.70001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_881_generated", "manhole_dn": "manhole_882_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387946.009428307646886, 5865930.175072746351361 ], [ 1387948.700822412036359, 5865972.722005739808083 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_47_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_882_generated", "manhole_dn": "manhole_883_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387948.700822412036359, 5865972.722005739808083 ], [ 1387944.872250664513558, 5866015.105105520226061 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_47_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_883_generated", "manhole_dn": "manhole_884_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387944.872250664513558, 5866015.105105520226061 ], [ 1387940.047370131826028, 5866057.463170127011836 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_47_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 803.9000244140625, "invlev_up": 814.20001220703125, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_884_generated", "manhole_dn": "manhole_870_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.047370131826028, 5866057.463170127011836 ], [ 1387932.086585889104754, 5866099.149365295656025 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_48_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_48", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_48", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 786.29998779296875, "invlev_up": 801.4000244140625, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_870_generated", "manhole_dn": "manhole_885_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387932.086585889104754, 5866099.149365295656025 ], [ 1387975.279995472636074, 5866107.425722245126963 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E125", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.5, "elevtn_dn": 910.4000244140625, "invlev_up": 907.0, "invlev_dn": 907.9000244140625, "manhole_up": "manhole_886_generated", "manhole_dn": "manhole_887_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392926.966794768813998, 5866808.501405037939548 ], [ 1392879.417931769276038, 5866793.491589142940938 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E126", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 910.4000244140625, "elevtn_dn": 910.4000244140625, "invlev_up": 907.9000244140625, "invlev_dn": 907.9000244140625, "manhole_up": "manhole_887_generated", "manhole_dn": "manhole_888_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392879.417931769276038, 5866793.491589142940938 ], [ 1392831.869068769738078, 5866778.481773247942328 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E127", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 910.4000244140625, "elevtn_dn": 865.0, "invlev_up": 907.9000244140625, "invlev_dn": 862.5, "manhole_up": "manhole_888_generated", "manhole_dn": "manhole_889_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392831.869068769738078, 5866778.481773247942328 ], [ 1392784.320205770200118, 5866763.471957352943718 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E128", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 865.0, "elevtn_dn": 865.0, "invlev_up": 862.5, "invlev_dn": 862.5, "manhole_up": "manhole_889_generated", "manhole_dn": "manhole_890_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392784.320205770200118, 5866763.471957352943718 ], [ 1392736.771342770429328, 5866748.462141457945108 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E129", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 865.0, "elevtn_dn": 878.4000244140625, "invlev_up": 862.5, "invlev_dn": 875.9000244140625, "manhole_up": "manhole_890_generated", "manhole_dn": "manhole_891_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392736.771342770429328, 5866748.462141457945108 ], [ 1392689.222479770891368, 5866733.452325562946498 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E130", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 878.4000244140625, "elevtn_dn": 878.4000244140625, "invlev_up": 875.9000244140625, "invlev_dn": 875.9000244140625, "manhole_up": "manhole_891_generated", "manhole_dn": "manhole_892_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392689.222479770891368, 5866733.452325562946498 ], [ 1392641.673616771353409, 5866718.442509667947888 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E131", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 878.4000244140625, "elevtn_dn": 904.9000244140625, "invlev_up": 875.9000244140625, "invlev_dn": 902.4000244140625, "manhole_up": "manhole_892_generated", "manhole_dn": "manhole_893_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392641.673616771353409, 5866718.442509667947888 ], [ 1392594.124753771815449, 5866703.432693773880601 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E132", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 904.9000244140625, "elevtn_dn": 904.9000244140625, "invlev_up": 902.4000244140625, "invlev_dn": 902.4000244140625, "manhole_up": "manhole_893_generated", "manhole_dn": "manhole_894_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392594.124753771815449, 5866703.432693773880601 ], [ 1392546.575890772277489, 5866688.422877878881991 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E133", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 904.9000244140625, "elevtn_dn": 931.5, "invlev_up": 902.4000244140625, "invlev_dn": 929.0, "manhole_up": "manhole_894_generated", "manhole_dn": "manhole_895_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392546.575890772277489, 5866688.422877878881991 ], [ 1392499.02702777273953, 5866673.413061983883381 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E134", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 931.5, "elevtn_dn": 931.5, "invlev_up": 929.0, "invlev_dn": 929.0, "manhole_up": "manhole_895_generated", "manhole_dn": "manhole_896_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392499.02702777273953, 5866673.413061983883381 ], [ 1392451.47816477320157, 5866658.403246088884771 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E135", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 931.5, "elevtn_dn": 926.29998779296875, "invlev_up": 929.0, "invlev_dn": 923.79998779296875, "manhole_up": "manhole_896_generated", "manhole_dn": "manhole_897_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392451.47816477320157, 5866658.403246088884771 ], [ 1392403.92930177366361, 5866643.393430193886161 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E136", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 926.29998779296875, "elevtn_dn": 849.79998779296875, "invlev_up": 923.79998779296875, "invlev_dn": 847.29998779296875, "manhole_up": "manhole_897_generated", "manhole_dn": "manhole_898_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392403.92930177366361, 5866643.393430193886161 ], [ 1392356.380438774125651, 5866628.383614298887551 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E137", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 849.79998779296875, "elevtn_dn": 875.20001220703125, "invlev_up": 847.29998779296875, "invlev_dn": 872.70001220703125, "manhole_up": "manhole_898_generated", "manhole_dn": "manhole_899_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392356.380438774125651, 5866628.383614298887551 ], [ 1392308.831575774587691, 5866613.373798403888941 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E138", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 875.20001220703125, "elevtn_dn": 875.20001220703125, "invlev_up": 872.70001220703125, "invlev_dn": 872.70001220703125, "manhole_up": "manhole_899_generated", "manhole_dn": "manhole_900_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392308.831575774587691, 5866613.373798403888941 ], [ 1392261.282712775049731, 5866598.363982509821653 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E139", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 875.20001220703125, "elevtn_dn": 928.10003662109375, "invlev_up": 872.70001220703125, "invlev_dn": 925.60003662109375, "manhole_up": "manhole_900_generated", "manhole_dn": "manhole_901_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392261.282712775049731, 5866598.363982509821653 ], [ 1392213.733849775511771, 5866583.354166614823043 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E140", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 928.10003662109375, "elevtn_dn": 928.10003662109375, "invlev_up": 925.60003662109375, "invlev_dn": 925.60003662109375, "manhole_up": "manhole_901_generated", "manhole_dn": "manhole_902_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392213.733849775511771, 5866583.354166614823043 ], [ 1392166.184986775973812, 5866568.344350719824433 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E141", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 928.10003662109375, "elevtn_dn": 936.79998779296875, "invlev_up": 925.60003662109375, "invlev_dn": 934.29998779296875, "manhole_up": "manhole_902_generated", "manhole_dn": "manhole_903_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392166.184986775973812, 5866568.344350719824433 ], [ 1392119.234377897810191, 5866551.59017149079591 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E142", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 936.79998779296875, "elevtn_dn": 936.79998779296875, "invlev_up": 934.29998779296875, "invlev_dn": 934.29998779296875, "manhole_up": "manhole_903_generated", "manhole_dn": "manhole_904_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392119.234377897810191, 5866551.59017149079591 ], [ 1392072.481987217208371, 5866534.25803626794368 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E143", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 936.79998779296875, "elevtn_dn": 929.79998779296875, "invlev_up": 934.29998779296875, "invlev_dn": 927.29998779296875, "manhole_up": "manhole_904_generated", "manhole_dn": "manhole_905_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392072.481987217208371, 5866534.25803626794368 ], [ 1392025.729596536839381, 5866516.925901044160128 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E144", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 929.79998779296875, "elevtn_dn": 892.29998779296875, "invlev_up": 927.29998779296875, "invlev_dn": 889.79998779296875, "manhole_up": "manhole_905_generated", "manhole_dn": "manhole_906_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392025.729596536839381, 5866516.925901044160128 ], [ 1391978.977205856470391, 5866499.593765820376575 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E145", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 892.29998779296875, "elevtn_dn": 911.4000244140625, "invlev_up": 889.79998779296875, "invlev_dn": 908.9000244140625, "manhole_up": "manhole_906_generated", "manhole_dn": "manhole_907_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391978.977205856470391, 5866499.593765820376575 ], [ 1391932.224815175868571, 5866482.261630596593022 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E146", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.4000244140625, "elevtn_dn": 911.4000244140625, "invlev_up": 908.9000244140625, "invlev_dn": 908.9000244140625, "manhole_up": "manhole_907_generated", "manhole_dn": "manhole_908_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391932.224815175868571, 5866482.261630596593022 ], [ 1391885.472424495499581, 5866464.92949537280947 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E147", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.4000244140625, "elevtn_dn": 933.20001220703125, "invlev_up": 908.9000244140625, "invlev_dn": 930.70001220703125, "manhole_up": "manhole_908_generated", "manhole_dn": "manhole_909_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391885.472424495499581, 5866464.92949537280947 ], [ 1391838.720033814897761, 5866447.59736014995724 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E148", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.20001220703125, "elevtn_dn": 933.20001220703125, "invlev_up": 930.70001220703125, "invlev_dn": 930.70001220703125, "manhole_up": "manhole_909_generated", "manhole_dn": "manhole_910_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391838.720033814897761, 5866447.59736014995724 ], [ 1391791.967643134528771, 5866430.265224926173687 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E149", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.20001220703125, "elevtn_dn": 939.4000244140625, "invlev_up": 930.70001220703125, "invlev_dn": 936.9000244140625, "manhole_up": "manhole_910_generated", "manhole_dn": "manhole_911_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391791.967643134528771, 5866430.265224926173687 ], [ 1391745.215252453926951, 5866412.933089702390134 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E150", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 939.4000244140625, "elevtn_dn": 939.4000244140625, "invlev_up": 936.9000244140625, "invlev_dn": 936.9000244140625, "manhole_up": "manhole_911_generated", "manhole_dn": "manhole_912_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391745.215252453926951, 5866412.933089702390134 ], [ 1391698.462861773557961, 5866395.600954478606582 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E151", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 939.4000244140625, "elevtn_dn": 952.70001220703125, "invlev_up": 936.9000244140625, "invlev_dn": 950.20001220703125, "manhole_up": "manhole_912_generated", "manhole_dn": "manhole_913_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391698.462861773557961, 5866395.600954478606582 ], [ 1391651.710471092956141, 5866378.268819254823029 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E152", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.70001220703125, "elevtn_dn": 889.4000244140625, "invlev_up": 950.20001220703125, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_913_generated", "manhole_dn": "manhole_914_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391651.710471092956141, 5866378.268819254823029 ], [ 1391604.958080412587151, 5866360.936684031039476 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E153", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 848.70001220703125, "invlev_up": 886.9000244140625, "invlev_dn": 846.20001220703125, "manhole_up": "manhole_914_generated", "manhole_dn": "manhole_915_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391604.958080412587151, 5866360.936684031039476 ], [ 1391558.205689732218161, 5866343.604548808187246 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E154", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 848.70001220703125, "elevtn_dn": 848.70001220703125, "invlev_up": 846.20001220703125, "invlev_dn": 846.20001220703125, "manhole_up": "manhole_915_generated", "manhole_dn": "manhole_916_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391558.205689732218161, 5866343.604548808187246 ], [ 1391511.453299051616341, 5866326.272413584403694 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E155", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 848.70001220703125, "elevtn_dn": 846.0, "invlev_up": 846.20001220703125, "invlev_dn": 843.5, "manhole_up": "manhole_916_generated", "manhole_dn": "manhole_917_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391511.453299051616341, 5866326.272413584403694 ], [ 1391464.700908371247351, 5866308.940278360620141 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E156", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.0, "elevtn_dn": 846.0, "invlev_up": 843.5, "invlev_dn": 843.5, "manhole_up": "manhole_917_generated", "manhole_dn": "manhole_918_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391464.700908371247351, 5866308.940278360620141 ], [ 1391417.948517690645531, 5866291.608143136836588 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E157", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.0, "elevtn_dn": 849.9000244140625, "invlev_up": 843.5, "invlev_dn": 847.4000244140625, "manhole_up": "manhole_918_generated", "manhole_dn": "manhole_919_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391417.948517690645531, 5866291.608143136836588 ], [ 1391371.196127010276541, 5866274.276007913053036 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E158", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 849.9000244140625, "elevtn_dn": 849.9000244140625, "invlev_up": 847.4000244140625, "invlev_dn": 847.4000244140625, "manhole_up": "manhole_919_generated", "manhole_dn": "manhole_920_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391371.196127010276541, 5866274.276007913053036 ], [ 1391321.986832652939484, 5866269.550851707346737 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E159", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 849.9000244140625, "elevtn_dn": 895.70001220703125, "invlev_up": 847.4000244140625, "invlev_dn": 893.20001220703125, "manhole_up": "manhole_920_generated", "manhole_dn": "manhole_921_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391321.986832652939484, 5866269.550851707346737 ], [ 1391272.147464629728347, 5866268.058758955448866 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E160", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 895.70001220703125, "elevtn_dn": 895.70001220703125, "invlev_up": 893.20001220703125, "invlev_dn": 893.20001220703125, "manhole_up": "manhole_921_generated", "manhole_dn": "manhole_922_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391272.147464629728347, 5866268.058758955448866 ], [ 1391222.30809660628438, 5866266.566666204482317 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E161", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 895.70001220703125, "elevtn_dn": 932.0, "invlev_up": 893.20001220703125, "invlev_dn": 929.5, "manhole_up": "manhole_922_generated", "manhole_dn": "manhole_923_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391222.30809660628438, 5866266.566666204482317 ], [ 1391172.468728582840413, 5866265.074573452584445 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E162", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 932.0, "invlev_up": 929.5, "invlev_dn": 929.5, "manhole_up": "manhole_923_generated", "manhole_dn": "manhole_924_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391172.468728582840413, 5866265.074573452584445 ], [ 1391122.629360559629276, 5866263.582480700686574 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E163", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 915.20001220703125, "invlev_up": 929.5, "invlev_dn": 912.70001220703125, "manhole_up": "manhole_924_generated", "manhole_dn": "manhole_925_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391122.629360559629276, 5866263.582480700686574 ], [ 1391072.789992536185309, 5866262.090387949720025 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E164", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.20001220703125, "elevtn_dn": 880.70001220703125, "invlev_up": 912.70001220703125, "invlev_dn": 878.20001220703125, "manhole_up": "manhole_925_generated", "manhole_dn": "manhole_926_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391072.789992536185309, 5866262.090387949720025 ], [ 1391022.950624512741342, 5866260.598295197822154 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E165", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 880.70001220703125, "elevtn_dn": 880.70001220703125, "invlev_up": 878.20001220703125, "invlev_dn": 878.20001220703125, "manhole_up": "manhole_926_generated", "manhole_dn": "manhole_927_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391022.950624512741342, 5866260.598295197822154 ], [ 1390973.111256489530206, 5866259.106202445924282 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E166", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 880.70001220703125, "elevtn_dn": 889.4000244140625, "invlev_up": 878.20001220703125, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_927_generated", "manhole_dn": "manhole_928_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390973.111256489530206, 5866259.106202445924282 ], [ 1390923.271888466086239, 5866257.614109694957733 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E167", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 889.4000244140625, "invlev_up": 886.9000244140625, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_928_generated", "manhole_dn": "manhole_929_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390923.271888466086239, 5866257.614109694957733 ], [ 1390873.432520442642272, 5866256.122016943059862 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E168", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 935.79998779296875, "invlev_up": 886.9000244140625, "invlev_dn": 933.29998779296875, "manhole_up": "manhole_929_generated", "manhole_dn": "manhole_930_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390873.432520442642272, 5866256.122016943059862 ], [ 1390823.593152419198304, 5866254.62992419116199 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E169", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.79998779296875, "elevtn_dn": 935.79998779296875, "invlev_up": 933.29998779296875, "invlev_dn": 933.29998779296875, "manhole_up": "manhole_930_generated", "manhole_dn": "manhole_931_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390823.593152419198304, 5866254.62992419116199 ], [ 1390773.753784395987168, 5866253.137831440195441 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E170", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.79998779296875, "elevtn_dn": 957.79998779296875, "invlev_up": 933.29998779296875, "invlev_dn": 955.29998779296875, "manhole_up": "manhole_931_generated", "manhole_dn": "manhole_932_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390773.753784395987168, 5866253.137831440195441 ], [ 1390723.914416372543201, 5866251.64573868829757 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E171", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.79998779296875, "elevtn_dn": 957.79998779296875, "invlev_up": 955.29998779296875, "invlev_dn": 955.29998779296875, "manhole_up": "manhole_932_generated", "manhole_dn": "manhole_933_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390723.914416372543201, 5866251.64573868829757 ], [ 1390674.075048349099234, 5866250.153645936399698 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E172", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.79998779296875, "elevtn_dn": 957.0, "invlev_up": 955.29998779296875, "invlev_dn": 954.5, "manhole_up": "manhole_933_generated", "manhole_dn": "manhole_934_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390674.075048349099234, 5866250.153645936399698 ], [ 1390624.235680325888097, 5866248.661553185433149 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E173", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.0, "elevtn_dn": 957.0, "invlev_up": 954.5, "invlev_dn": 954.5, "manhole_up": "manhole_934_generated", "manhole_dn": "manhole_935_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390624.235680325888097, 5866248.661553185433149 ], [ 1390574.39631230244413, 5866247.169460433535278 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E174", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.0, "elevtn_dn": 964.5, "invlev_up": 954.5, "invlev_dn": 962.0, "manhole_up": "manhole_935_generated", "manhole_dn": "manhole_936_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390574.39631230244413, 5866247.169460433535278 ], [ 1390524.556944279000163, 5866245.677367681637406 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E175", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 964.5, "invlev_up": 962.0, "invlev_dn": 962.0, "manhole_up": "manhole_936_generated", "manhole_dn": "manhole_937_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390524.556944279000163, 5866245.677367681637406 ], [ 1390474.717576255789027, 5866244.185274930670857 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E176", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 948.5, "invlev_up": 962.0, "invlev_dn": 946.0, "manhole_up": "manhole_937_generated", "manhole_dn": "manhole_938_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390474.717576255789027, 5866244.185274930670857 ], [ 1390424.87820823234506, 5866242.693182178772986 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E177", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 948.5, "elevtn_dn": 970.10003662109375, "invlev_up": 946.0, "invlev_dn": 967.60003662109375, "manhole_up": "manhole_938_generated", "manhole_dn": "manhole_939_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390424.87820823234506, 5866242.693182178772986 ], [ 1390375.038840208901092, 5866241.201089426875114 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E178", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 970.10003662109375, "elevtn_dn": 970.10003662109375, "invlev_up": 967.60003662109375, "invlev_dn": 967.60003662109375, "manhole_up": "manhole_939_generated", "manhole_dn": "manhole_940_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390375.038840208901092, 5866241.201089426875114 ], [ 1390325.199472185689956, 5866239.708996675908566 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E179", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 970.10003662109375, "elevtn_dn": 975.4000244140625, "invlev_up": 967.60003662109375, "invlev_dn": 972.9000244140625, "manhole_up": "manhole_940_generated", "manhole_dn": "manhole_941_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390325.199472185689956, 5866239.708996675908566 ], [ 1390275.360104162245989, 5866238.216903924010694 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E180", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 975.4000244140625, "elevtn_dn": 975.4000244140625, "invlev_up": 972.9000244140625, "invlev_dn": 972.9000244140625, "manhole_up": "manhole_941_generated", "manhole_dn": "manhole_942_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390275.360104162245989, 5866238.216903924010694 ], [ 1390225.520736138802022, 5866236.724811173044145 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E181", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 975.4000244140625, "elevtn_dn": 1034.5, "invlev_up": 972.9000244140625, "invlev_dn": 1032.0, "manhole_up": "manhole_942_generated", "manhole_dn": "manhole_943_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390225.520736138802022, 5866236.724811173044145 ], [ 1390175.681368115358055, 5866235.232718421146274 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E182", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1034.5, "elevtn_dn": 1034.5, "invlev_up": 1032.0, "invlev_dn": 1032.0, "manhole_up": "manhole_943_generated", "manhole_dn": "manhole_944_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390175.681368115358055, 5866235.232718421146274 ], [ 1390125.842000092146918, 5866233.740625669248402 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E183", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1034.5, "elevtn_dn": 1053.9000244140625, "invlev_up": 1032.0, "invlev_dn": 1051.4000244140625, "manhole_up": "manhole_944_generated", "manhole_dn": "manhole_945_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390125.842000092146918, 5866233.740625669248402 ], [ 1390076.002632068702951, 5866232.248532918281853 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E184", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.9000244140625, "elevtn_dn": 956.9000244140625, "invlev_up": 1051.4000244140625, "invlev_dn": 954.4000244140625, "manhole_up": "manhole_945_generated", "manhole_dn": "manhole_946_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390076.002632068702951, 5866232.248532918281853 ], [ 1390026.163264045258984, 5866230.756440166383982 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E185", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 956.9000244140625, "elevtn_dn": 988.79998779296875, "invlev_up": 954.4000244140625, "invlev_dn": 986.29998779296875, "manhole_up": "manhole_946_generated", "manhole_dn": "manhole_947_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390026.163264045258984, 5866230.756440166383982 ], [ 1389976.323896022047848, 5866229.26434741448611 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E186", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 988.79998779296875, "elevtn_dn": 988.79998779296875, "invlev_up": 986.29998779296875, "invlev_dn": 986.29998779296875, "manhole_up": "manhole_947_generated", "manhole_dn": "manhole_948_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389976.323896022047848, 5866229.26434741448611 ], [ 1389926.48452799860388, 5866227.772254663519561 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E187", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 988.79998779296875, "elevtn_dn": 1051.0999755859375, "invlev_up": 986.29998779296875, "invlev_dn": 1048.5999755859375, "manhole_up": "manhole_948_generated", "manhole_dn": "manhole_949_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389926.48452799860388, 5866227.772254663519561 ], [ 1389876.645159975159913, 5866226.28016191162169 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E188", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1051.0999755859375, "elevtn_dn": 1051.0999755859375, "invlev_up": 1048.5999755859375, "invlev_dn": 1048.5999755859375, "manhole_up": "manhole_949_generated", "manhole_dn": "manhole_950_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389876.645159975159913, 5866226.28016191162169 ], [ 1389826.805791951948777, 5866224.788069159723818 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E189", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1051.0999755859375, "elevtn_dn": 1066.9000244140625, "invlev_up": 1048.5999755859375, "invlev_dn": 1064.4000244140625, "manhole_up": "manhole_950_generated", "manhole_dn": "manhole_951_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389826.805791951948777, 5866224.788069159723818 ], [ 1389776.96642392850481, 5866223.295976408757269 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E190", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1066.9000244140625, "elevtn_dn": 1031.2000732421875, "invlev_up": 1064.4000244140625, "invlev_dn": 1028.7000732421875, "manhole_up": "manhole_951_generated", "manhole_dn": "manhole_952_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389776.96642392850481, 5866223.295976408757269 ], [ 1389727.141182830790058, 5866221.468200048431754 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E191", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1031.2000732421875, "elevtn_dn": 1031.2000732421875, "invlev_up": 1028.7000732421875, "invlev_dn": 1028.7000732421875, "manhole_up": "manhole_952_generated", "manhole_dn": "manhole_953_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389727.141182830790058, 5866221.468200048431754 ], [ 1389677.352675863076001, 5866218.767548334784806 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E192", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1031.2000732421875, "elevtn_dn": 986.60003662109375, "invlev_up": 1028.7000732421875, "invlev_dn": 984.10003662109375, "manhole_up": "manhole_953_generated", "manhole_dn": "manhole_954_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389677.352675863076001, 5866218.767548334784806 ], [ 1389627.564168895594776, 5866216.066896621137857 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E193", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 986.60003662109375, "elevtn_dn": 986.60003662109375, "invlev_up": 984.10003662109375, "invlev_dn": 984.10003662109375, "manhole_up": "manhole_954_generated", "manhole_dn": "manhole_955_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389627.564168895594776, 5866216.066896621137857 ], [ 1389577.775661927880719, 5866213.366244907490909 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E194", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 986.60003662109375, "elevtn_dn": 964.70001220703125, "invlev_up": 984.10003662109375, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_955_generated", "manhole_dn": "manhole_956_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389577.775661927880719, 5866213.366244907490909 ], [ 1389527.987154960166663, 5866210.665593194775283 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E195", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 964.70001220703125, "invlev_up": 962.20001220703125, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_956_generated", "manhole_dn": "manhole_957_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389527.987154960166663, 5866210.665593194775283 ], [ 1389478.198647992452607, 5866207.964941481128335 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E196", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 996.29998779296875, "invlev_up": 962.20001220703125, "invlev_dn": 993.79998779296875, "manhole_up": "manhole_957_generated", "manhole_dn": "manhole_958_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389478.198647992452607, 5866207.964941481128335 ], [ 1389428.41014102473855, 5866205.264289767481387 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E197", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 996.29998779296875, "elevtn_dn": 996.29998779296875, "invlev_up": 993.79998779296875, "invlev_dn": 993.79998779296875, "manhole_up": "manhole_958_generated", "manhole_dn": "manhole_959_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389428.41014102473855, 5866205.264289767481387 ], [ 1389378.621634057024494, 5866202.563638053834438 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E198", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 996.29998779296875, "elevtn_dn": 1030.4000244140625, "invlev_up": 993.79998779296875, "invlev_dn": 1027.9000244140625, "manhole_up": "manhole_959_generated", "manhole_dn": "manhole_960_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389378.621634057024494, 5866202.563638053834438 ], [ 1389328.833127089310437, 5866199.86298634018749 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E199", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1030.4000244140625, "elevtn_dn": 1030.4000244140625, "invlev_up": 1027.9000244140625, "invlev_dn": 1027.9000244140625, "manhole_up": "manhole_960_generated", "manhole_dn": "manhole_961_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389328.833127089310437, 5866199.86298634018749 ], [ 1389279.044620121829212, 5866197.162334626540542 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E200", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1030.4000244140625, "elevtn_dn": 1053.800048828125, "invlev_up": 1027.9000244140625, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_961_generated", "manhole_dn": "manhole_962_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389279.044620121829212, 5866197.162334626540542 ], [ 1389229.256113154115155, 5866194.461682912893593 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E201", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1053.800048828125, "invlev_up": 1051.300048828125, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_962_generated", "manhole_dn": "manhole_963_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389229.256113154115155, 5866194.461682912893593 ], [ 1389179.467606186401099, 5866191.761031199246645 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E202", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1067.5999755859375, "invlev_up": 1051.300048828125, "invlev_dn": 1065.0999755859375, "manhole_up": "manhole_963_generated", "manhole_dn": "manhole_964_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389179.467606186401099, 5866191.761031199246645 ], [ 1389129.679099218687043, 5866189.060379485599697 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E203", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1067.5999755859375, "elevtn_dn": 1070.7000732421875, "invlev_up": 1065.0999755859375, "invlev_dn": 1068.2000732421875, "manhole_up": "manhole_964_generated", "manhole_dn": "manhole_965_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389129.679099218687043, 5866189.060379485599697 ], [ 1389079.890592250972986, 5866186.359727771952748 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E204", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1070.7000732421875, "elevtn_dn": 1070.7000732421875, "invlev_up": 1068.2000732421875, "invlev_dn": 1068.2000732421875, "manhole_up": "manhole_965_generated", "manhole_dn": "manhole_966_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389079.890592250972986, 5866186.359727771952748 ], [ 1389030.10208528325893, 5866183.6590760583058 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E205", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1070.7000732421875, "elevtn_dn": 1075.0, "invlev_up": 1068.2000732421875, "invlev_dn": 1072.5, "manhole_up": "manhole_966_generated", "manhole_dn": "manhole_967_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389030.10208528325893, 5866183.6590760583058 ], [ 1388980.313578315777704, 5866180.958424345590174 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E206", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1075.0, "elevtn_dn": 1075.0, "invlev_up": 1072.5, "invlev_dn": 1072.5, "manhole_up": "manhole_967_generated", "manhole_dn": "manhole_968_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388980.313578315777704, 5866180.958424345590174 ], [ 1388930.525071348063648, 5866178.257772631943226 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E207", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1075.0, "elevtn_dn": 1074.0999755859375, "invlev_up": 1072.5, "invlev_dn": 1071.5999755859375, "manhole_up": "manhole_968_generated", "manhole_dn": "manhole_969_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388930.525071348063648, 5866178.257772631943226 ], [ 1388880.736564380349591, 5866175.557120918296278 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E208", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1074.0999755859375, "elevtn_dn": 1074.0999755859375, "invlev_up": 1071.5999755859375, "invlev_dn": 1071.5999755859375, "manhole_up": "manhole_969_generated", "manhole_dn": "manhole_970_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388880.736564380349591, 5866175.557120918296278 ], [ 1388830.948057412635535, 5866172.856469204649329 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E209", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1074.0999755859375, "elevtn_dn": 1053.800048828125, "invlev_up": 1071.5999755859375, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_970_generated", "manhole_dn": "manhole_971_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388830.948057412635535, 5866172.856469204649329 ], [ 1388781.159550444921479, 5866170.155817491002381 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E210", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1053.800048828125, "invlev_up": 1051.300048828125, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_971_generated", "manhole_dn": "manhole_972_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388781.159550444921479, 5866170.155817491002381 ], [ 1388731.371043477207422, 5866167.455165777355433 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E211", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1017.0, "invlev_up": 1051.300048828125, "invlev_dn": 1014.5, "manhole_up": "manhole_972_generated", "manhole_dn": "manhole_973_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388731.371043477207422, 5866167.455165777355433 ], [ 1388681.582536509493366, 5866164.754514063708484 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E212", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1017.0, "elevtn_dn": 1017.0, "invlev_up": 1014.5, "invlev_dn": 1014.5, "manhole_up": "manhole_973_generated", "manhole_dn": "manhole_974_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388681.582536509493366, 5866164.754514063708484 ], [ 1388631.79402954201214, 5866162.053862350061536 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E213", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1017.0, "elevtn_dn": 973.20001220703125, "invlev_up": 1014.5, "invlev_dn": 970.70001220703125, "manhole_up": "manhole_974_generated", "manhole_dn": "manhole_975_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388631.79402954201214, 5866162.053862350061536 ], [ 1388582.005522574298084, 5866159.353210636414587 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E214", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 973.20001220703125, "elevtn_dn": 973.20001220703125, "invlev_up": 970.70001220703125, "invlev_dn": 970.70001220703125, "manhole_up": "manhole_975_generated", "manhole_dn": "manhole_976_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388582.005522574298084, 5866159.353210636414587 ], [ 1388532.217015606584027, 5866156.652558922767639 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E215", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 973.20001220703125, "elevtn_dn": 935.20001220703125, "invlev_up": 970.70001220703125, "invlev_dn": 932.70001220703125, "manhole_up": "manhole_976_generated", "manhole_dn": "manhole_977_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388532.217015606584027, 5866156.652558922767639 ], [ 1388482.428508638869971, 5866153.951907209120691 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E216", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.20001220703125, "elevtn_dn": 935.20001220703125, "invlev_up": 932.70001220703125, "invlev_dn": 932.70001220703125, "manhole_up": "manhole_977_generated", "manhole_dn": "manhole_978_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388482.428508638869971, 5866153.951907209120691 ], [ 1388432.640001671155915, 5866151.251255496405065 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E217", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.20001220703125, "elevtn_dn": 895.79998779296875, "invlev_up": 932.70001220703125, "invlev_dn": 893.29998779296875, "manhole_up": "manhole_978_generated", "manhole_dn": "manhole_979_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388432.640001671155915, 5866151.251255496405065 ], [ 1388382.851494703441858, 5866148.550603782758117 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E218", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 895.79998779296875, "elevtn_dn": 852.60003662109375, "invlev_up": 893.29998779296875, "invlev_dn": 850.10003662109375, "manhole_up": "manhole_979_generated", "manhole_dn": "manhole_980_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388382.851494703441858, 5866148.550603782758117 ], [ 1388333.062987735960633, 5866145.849952069111168 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E219", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 852.60003662109375, "elevtn_dn": 852.60003662109375, "invlev_up": 850.10003662109375, "invlev_dn": 850.10003662109375, "manhole_up": "manhole_980_generated", "manhole_dn": "manhole_981_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388333.062987735960633, 5866145.849952069111168 ], [ 1388283.274480768246576, 5866143.14930035546422 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E220", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 852.60003662109375, "elevtn_dn": 818.4000244140625, "invlev_up": 850.10003662109375, "invlev_dn": 815.9000244140625, "manhole_up": "manhole_981_generated", "manhole_dn": "manhole_982_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388283.274480768246576, 5866143.14930035546422 ], [ 1388233.48597380053252, 5866140.448648641817272 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E221", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.4000244140625, "elevtn_dn": 818.4000244140625, "invlev_up": 815.9000244140625, "invlev_dn": 815.9000244140625, "manhole_up": "manhole_982_generated", "manhole_dn": "manhole_983_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388233.48597380053252, 5866140.448648641817272 ], [ 1388183.697466832818463, 5866137.747996928170323 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 792.20001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_851_generated", "manhole_dn": "manhole_984_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387913.197226775344461, 5865736.839239663444459 ], [ 1387925.20445894007571, 5865784.545682998374104 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 804.4000244140625, "invlev_up": 792.20001220703125, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_984_generated", "manhole_dn": "manhole_985_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387925.20445894007571, 5865784.545682998374104 ], [ 1387937.21169110503979, 5865832.252126332372427 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_985_generated", "manhole_dn": "manhole_986_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387937.21169110503979, 5865832.252126332372427 ], [ 1387954.8270876808092, 5865878.043407939374447 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_986_generated", "manhole_dn": "manhole_987_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387954.8270876808092, 5865878.043407939374447 ], [ 1387967.620662312954664, 5865925.436966767534614 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 778.20001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_987_generated", "manhole_dn": "manhole_988_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387967.620662312954664, 5865925.436966767534614 ], [ 1387969.561903131194413, 5865974.386314341798425 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_988_generated", "manhole_dn": "manhole_989_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.561903131194413, 5865974.386314341798425 ], [ 1387968.98255812516436, 5866023.571071763522923 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_989_generated", "manhole_dn": "manhole_990_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387968.98255812516436, 5866023.571071763522923 ], [ 1387969.225197304505855, 5866072.657253311946988 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 786.29998779296875, "invlev_up": 775.70001220703125, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_990_generated", "manhole_dn": "manhole_991_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.225197304505855, 5866072.657253311946988 ], [ 1387988.247399942483753, 5866112.298415473662317 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 786.29998779296875, "invlev_up": 783.79998779296875, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_991_generated", "manhole_dn": "manhole_992_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387988.247399942483753, 5866112.298415473662317 ], [ 1388034.037428337847814, 5866130.255607943050563 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 786.29998779296875, "invlev_up": 783.79998779296875, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_992_generated", "manhole_dn": "manhole_993_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388034.037428337847814, 5866130.255607943050563 ], [ 1387988.210684564430267, 5866144.678138472139835 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 803.9000244140625, "invlev_up": 783.79998779296875, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_993_generated", "manhole_dn": "manhole_994_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387988.210684564430267, 5866144.678138472139835 ], [ 1387944.406121137319133, 5866164.065103021450341 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_994_generated", "manhole_dn": "manhole_995_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387944.406121137319133, 5866164.065103021450341 ], [ 1387898.376188111724332, 5866173.560075835324824 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 827.70001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_995_generated", "manhole_dn": "manhole_996_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387898.376188111724332, 5866173.560075835324824 ], [ 1387861.922560503939167, 5866145.113870099186897 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_996_generated", "manhole_dn": "manhole_997_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387861.922560503939167, 5866145.113870099186897 ], [ 1387862.597008766839281, 5866099.287653629668057 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_997_generated", "manhole_dn": "manhole_998_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387862.597008766839281, 5866099.287653629668057 ], [ 1387894.296242429409176, 5866064.31225199252367 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_998_generated", "manhole_dn": "manhole_999_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387894.296242429409176, 5866064.31225199252367 ], [ 1387918.333023339277133, 5866023.860149594023824 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_999_generated", "manhole_dn": "manhole_1000_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387918.333023339277133, 5866023.860149594023824 ], [ 1387925.576027213362977, 5865976.462517648003995 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 804.4000244140625, "invlev_up": 814.20001220703125, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1000_generated", "manhole_dn": "manhole_1001_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387925.576027213362977, 5865976.462517648003995 ], [ 1387926.166851800866425, 5865928.505292822606862 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1001_generated", "manhole_dn": "manhole_1002_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387926.166851800866425, 5865928.505292822606862 ], [ 1387922.175474973395467, 5865880.628693707287312 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1002_generated", "manhole_dn": "manhole_1003_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387922.175474973395467, 5865880.628693707287312 ], [ 1387918.184098146157339, 5865832.752094592899084 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 794.70001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_1003_generated", "manhole_dn": "manhole_1004_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387918.184098146157339, 5865832.752094592899084 ], [ 1387914.316889721900225, 5865784.868878290057182 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 792.20001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_1004_generated", "manhole_dn": "manhole_851_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387914.316889721900225, 5865784.868878290057182 ], [ 1387913.197226775344461, 5865736.839239663444459 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_52_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_52", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.4000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 815.9000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_983_generated", "manhole_dn": "manhole_1005_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388183.697466832818463, 5866137.747996928170323 ], [ 1388133.810787334572524, 5866135.250533932819963 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_52_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_52", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_1005_generated", "manhole_dn": "manhole_1006_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388133.810787334572524, 5866135.250533932819963 ], [ 1388083.924107836093754, 5866132.753070938400924 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_52_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_52", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 786.29998779296875, "invlev_up": 801.4000244140625, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_1006_generated", "manhole_dn": "manhole_992_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388083.924107836093754, 5866132.753070938400924 ], [ 1388034.037428337847814, 5866130.255607943050563 ] ] } }, +{ "type": "Feature", "properties": { "height": 22.5, "bedlev": 865.60003662109375, "width": 60.500781333333329, "branchid": "river_1", "branchtype": "river", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_1", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1394694.070276216836646, 5867648.108302162960172 ], [ 1394694.070276216836646, 5867513.239712204784155 ], [ 1394601.304033889202401, 5867378.373192292638123 ], [ 1394508.537791561568156, 5867243.508742331527174 ], [ 1394415.771549233933911, 5867243.508742331527174 ], [ 1394323.005306906066835, 5867108.646362232975662 ], [ 1394230.23906457843259, 5867108.646362232975662 ], [ 1394137.472822251031175, 5867108.646362232975662 ], [ 1394044.70657992339693, 5866973.78605190385133 ], [ 1393951.940337595762685, 5866973.78605190385133 ], [ 1393859.17409526812844, 5866973.78605190385133 ], [ 1393766.407852940494195, 5866838.927811251021922 ], [ 1393673.641610612627119, 5866838.927811251021922 ], [ 1393580.875368284992874, 5866838.927811251021922 ], [ 1393488.109125957358629, 5866838.927811251021922 ], [ 1393395.342883629724383, 5866838.927811251021922 ], [ 1393302.576641302322969, 5866838.927811251021922 ], [ 1393209.810398974688724, 5866838.927811251021922 ], [ 1393117.044156646821648, 5866704.071640183217824 ], [ 1393024.277914319187403, 5866704.071640183217824 ], [ 1392931.511671991553158, 5866704.071640183217824 ], [ 1392838.745429663918912, 5866704.071640183217824 ], [ 1392745.979187336284667, 5866569.217538607306778 ], [ 1392653.212945008650422, 5866569.217538607306778 ], [ 1392560.446702681016177, 5866569.217538607306778 ], [ 1392467.680460353381932, 5866569.217538607306778 ], [ 1392374.914218025747687, 5866569.217538607306778 ], [ 1392282.147975698113441, 5866434.365506432950497 ], [ 1392189.381733370479196, 5866299.515543567948043 ], [ 1392096.615491042844951, 5866299.515543567948043 ], [ 1392003.849248715210706, 5866299.515543567948043 ], [ 1391911.083006387576461, 5866299.515543567948043 ], [ 1391818.316764059709385, 5866164.667649918235838 ], [ 1391725.55052173207514, 5866164.667649918235838 ], [ 1391632.784279404673725, 5866164.667649918235838 ], [ 1391540.01803707703948, 5866164.667649918235838 ], [ 1391447.251794749405235, 5866164.667649918235838 ], [ 1391354.48555242177099, 5866164.667649918235838 ], [ 1391261.719310093903914, 5866164.667649918235838 ], [ 1391168.953067766269669, 5866164.667649918235838 ], [ 1391076.186825438635424, 5866164.667649918235838 ], [ 1390983.420583111001179, 5866164.667649918235838 ], [ 1390890.654340783366933, 5866164.667649918235838 ], [ 1390797.888098455965519, 5866029.821825394406915 ], [ 1390705.121856128098443, 5866029.821825394406915 ], [ 1390612.355613800464198, 5866029.821825394406915 ], [ 1390519.589371472829953, 5866029.821825394406915 ], [ 1390426.823129145195708, 5866029.821825394406915 ], [ 1390334.056886817561463, 5866029.821825394406915 ], [ 1390241.290644489927217, 5866029.821825394406915 ], [ 1390148.524402162292972, 5865894.978069902397692 ], [ 1390055.758159834658727, 5865894.978069902397692 ], [ 1389962.991917507024482, 5865760.136383352801204 ], [ 1389870.225675179390237, 5865760.136383352801204 ], [ 1389777.459432851755992, 5865760.136383352801204 ], [ 1389684.693190524121746, 5865760.136383352801204 ], [ 1389591.926948196487501, 5865760.136383352801204 ], [ 1389499.160705868853256, 5865625.296765649691224 ], [ 1389406.39446354098618, 5865625.296765649691224 ], [ 1389406.39446354098618, 5865490.459216705523431 ], [ 1389313.628221213351935, 5865355.623736422508955 ], [ 1389313.628221213351935, 5865220.790324714966118 ], [ 1389313.628221213351935, 5865085.958981488831341 ], [ 1389220.86197888571769, 5864951.129706650041044 ], [ 1389128.095736558316275, 5864816.302500107325613 ], [ 1389128.095736558316275, 5864681.477361769415438 ], [ 1389035.32949423068203, 5864546.654291545972228 ], [ 1389128.095736558316275, 5864411.833289342001081 ], [ 1389128.095736558316275, 5864277.014355068095028 ], [ 1389035.32949423068203, 5864142.197488628327847 ], [ 1388942.563251903047785, 5864007.382689936086535 ], [ 1388849.797009575180709, 5863872.569958896376193 ], [ 1388757.030767247546464, 5863872.569958896376193 ], [ 1388664.264524919912219, 5863737.759295416995883 ], [ 1388571.498282592277974, 5863602.950699406675994 ], [ 1388571.498282592277974, 5863468.144170773215592 ], [ 1388571.498282592277974, 5863333.339709427207708 ], [ 1388478.732040264643729, 5863333.339709427207708 ], [ 1388385.965797937009484, 5863198.537315272726119 ], [ 1388293.199555609375238, 5863198.537315272726119 ], [ 1388200.433313281740993, 5863198.537315272726119 ], [ 1388107.667070954106748, 5863063.736988220363855 ], [ 1388014.900828626472503, 5863063.736988220363855 ], [ 1387922.134586298838258, 5863063.736988220363855 ], [ 1387829.368343971204013, 5862928.938728176057339 ], [ 1387736.602101643569767, 5862794.142535050399601 ], [ 1387736.602101643569767, 5862659.348408752121031 ], [ 1387736.602101643569767, 5862524.556349185295403 ], [ 1387643.835859315935522, 5862389.766356259584427 ], [ 1387551.069616988068447, 5862254.978429886512458 ], [ 1387458.303374660667032, 5862254.978429886512458 ], [ 1387365.537132333032787, 5862254.978429886512458 ], [ 1387272.770890005398542, 5862254.978429886512458 ], [ 1387180.004647677764297, 5862254.978429886512458 ], [ 1387087.238405350130051, 5862254.978429886512458 ], [ 1386994.472163022495806, 5862120.192569970153272 ] ] } }, +{ "type": "Feature", "properties": { "height": 13.574996948242188, "bedlev": 813.29998779296875, "width": 63.595319, "branchid": "river_2", "branchtype": "river", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_2", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386066.809739745920524, 5868052.726493230089545 ], [ 1386159.575982073554769, 5868052.726493230089545 ], [ 1386252.342224401189014, 5867917.851692584343255 ], [ 1386345.108466728823259, 5867917.851692584343255 ], [ 1386437.874709056690335, 5867917.851692584343255 ], [ 1386530.64095138432458, 5867917.851692584343255 ], [ 1386623.407193711958826, 5867917.851692584343255 ], [ 1386716.17343603936024, 5867782.978962258435786 ], [ 1386808.939678366994485, 5867782.978962258435786 ], [ 1386901.70592069462873, 5867782.978962258435786 ], [ 1386994.472163022495806, 5867648.108302162960172 ], [ 1387087.238405350130051, 5867648.108302162960172 ], [ 1387180.004647677764297, 5867513.239712204784155 ], [ 1387272.770890005398542, 5867378.373192292638123 ], [ 1387365.537132333032787, 5867243.508742331527174 ], [ 1387458.303374660667032, 5867108.646362232975662 ], [ 1387551.069616988068447, 5867108.646362232975662 ], [ 1387643.835859315935522, 5867108.646362232975662 ], [ 1387736.602101643569767, 5866973.78605190385133 ], [ 1387829.368343971204013, 5866973.78605190385133 ], [ 1387829.368343971204013, 5866838.927811251021922 ], [ 1387829.368343971204013, 5866704.071640183217824 ], [ 1387829.368343971204013, 5866569.217538607306778 ], [ 1387922.134586298838258, 5866434.365506432950497 ], [ 1387922.134586298838258, 5866299.515543567948043 ], [ 1388014.900828626472503, 5866164.667649918235838 ], [ 1388014.900828626472503, 5866029.821825394406915 ], [ 1388014.900828626472503, 5865894.978069902397692 ], [ 1388014.900828626472503, 5865760.136383352801204 ], [ 1387922.134586298838258, 5865625.296765649691224 ], [ 1387922.134586298838258, 5865490.459216705523431 ], [ 1387922.134586298838258, 5865355.623736422508955 ], [ 1387922.134586298838258, 5865220.790324714966118 ], [ 1387922.134586298838258, 5865085.958981488831341 ], [ 1387829.368343971204013, 5864951.129706650041044 ], [ 1387829.368343971204013, 5864816.302500107325613 ], [ 1387829.368343971204013, 5864681.477361769415438 ], [ 1387829.368343971204013, 5864546.654291545972228 ], [ 1387829.368343971204013, 5864411.833289342001081 ], [ 1387829.368343971204013, 5864277.014355068095028 ], [ 1387736.602101643569767, 5864142.197488628327847 ], [ 1387643.835859315935522, 5864007.382689936086535 ], [ 1387551.069616988068447, 5863872.569958896376193 ], [ 1387551.069616988068447, 5863737.759295416995883 ], [ 1387458.303374660667032, 5863602.950699406675994 ], [ 1387365.537132333032787, 5863468.144170773215592 ], [ 1387272.770890005398542, 5863333.339709427207708 ], [ 1387272.770890005398542, 5863198.537315272726119 ], [ 1387180.004647677764297, 5863063.736988220363855 ], [ 1387087.238405350130051, 5862928.938728176057339 ], [ 1386994.472163022495806, 5862794.142535050399601 ], [ 1386901.70592069462873, 5862794.142535050399601 ], [ 1386808.939678366994485, 5862659.348408752121031 ], [ 1386716.17343603936024, 5862524.556349185295403 ], [ 1386716.17343603936024, 5862389.766356259584427 ], [ 1386716.17343603936024, 5862254.978429886512458 ], [ 1386808.939678366994485, 5862254.978429886512458 ], [ 1386901.70592069462873, 5862120.192569970153272 ], [ 1386994.472163022495806, 5862120.192569970153272 ] ] } }, +{ "type": "Feature", "properties": { "height": 21.70001220703125, "bedlev": 952.79998779296875, "width": 50.0, "branchid": "river_3", "branchtype": "river", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_3", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1391540.01803707703948, 5858077.577220032922924 ], [ 1391447.251794749405235, 5858077.577220032922924 ], [ 1391354.48555242177099, 5858077.577220032922924 ], [ 1391261.719310093903914, 5858077.577220032922924 ], [ 1391168.953067766269669, 5858077.577220032922924 ], [ 1391076.186825438635424, 5858212.301128903403878 ], [ 1390983.420583111001179, 5858212.301128903403878 ], [ 1390890.654340783366933, 5858212.301128903403878 ], [ 1390797.888098455965519, 5858077.577220032922924 ], [ 1390705.121856128098443, 5858077.577220032922924 ], [ 1390612.355613800464198, 5858077.577220032922924 ], [ 1390519.589371472829953, 5858077.577220032922924 ], [ 1390426.823129145195708, 5858077.577220032922924 ], [ 1390334.056886817561463, 5857942.855374777689576 ], [ 1390241.290644489927217, 5857942.855374777689576 ], [ 1390148.524402162292972, 5857942.855374777689576 ], [ 1390055.758159834658727, 5857808.135593040846288 ], [ 1389962.991917507024482, 5857808.135593040846288 ], [ 1389962.991917507024482, 5857673.41787473578006 ], [ 1389870.225675179390237, 5857673.41787473578006 ], [ 1389777.459432851755992, 5857673.41787473578006 ], [ 1389684.693190524121746, 5857808.135593040846288 ], [ 1389591.926948196487501, 5857808.135593040846288 ], [ 1389499.160705868853256, 5857808.135593040846288 ], [ 1389406.39446354098618, 5857808.135593040846288 ], [ 1389313.628221213351935, 5857942.855374777689576 ], [ 1389220.86197888571769, 5858077.577220032922924 ], [ 1389128.095736558316275, 5858212.301128903403878 ], [ 1389035.32949423068203, 5858212.301128903403878 ], [ 1388942.563251903047785, 5858347.02710147574544 ], [ 1388849.797009575180709, 5858347.02710147574544 ], [ 1388757.030767247546464, 5858347.02710147574544 ], [ 1388664.264524919912219, 5858481.755137845873833 ], [ 1388571.498282592277974, 5858481.755137845873833 ], [ 1388478.732040264643729, 5858481.755137845873833 ], [ 1388385.965797937009484, 5858481.755137845873833 ], [ 1388293.199555609375238, 5858481.755137845873833 ], [ 1388200.433313281740993, 5858616.485238100402057 ], [ 1388107.667070954106748, 5858751.217402336187661 ], [ 1388014.900828626472503, 5858885.951630645431578 ], [ 1387922.134586298838258, 5858885.951630645431578 ], [ 1387829.368343971204013, 5858885.951630645431578 ], [ 1387736.602101643569767, 5858885.951630645431578 ], [ 1387643.835859315935522, 5858885.951630645431578 ], [ 1387551.069616988068447, 5858885.951630645431578 ], [ 1387458.303374660667032, 5858885.951630645431578 ], [ 1387365.537132333032787, 5858885.951630645431578 ], [ 1387272.770890005398542, 5858885.951630645431578 ], [ 1387180.004647677764297, 5858885.951630645431578 ], [ 1387087.238405350130051, 5858885.951630645431578 ], [ 1386994.472163022495806, 5858885.951630645431578 ], [ 1386901.70592069462873, 5858885.951630645431578 ], [ 1386808.939678366994485, 5858885.951630645431578 ], [ 1386716.17343603936024, 5859020.687923114746809 ], [ 1386623.407193711958826, 5859020.687923114746809 ], [ 1386530.64095138432458, 5859020.687923114746809 ], [ 1386437.874709056690335, 5859020.687923114746809 ], [ 1386345.108466728823259, 5859020.687923114746809 ] ] } }, +{ "type": "Feature", "properties": { "height": 14.050003051757812, "bedlev": 724.29998779296875, "width": 60.93007025, "branchid": "river_4", "branchtype": "river", "branchorder": "1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_4", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386994.472163022495806, 5862120.192569970153272 ], [ 1386901.70592069462873, 5861985.408776421099901 ], [ 1386808.939678366994485, 5861850.627049146220088 ], [ 1386716.17343603936024, 5861715.847388052381575 ], [ 1386716.17343603936024, 5861581.069793051108718 ], [ 1386716.17343603936024, 5861446.294264048337936 ], [ 1386648.271799877518788, 5861347.644815167412162 ] ] } }, +{ "type": "Feature", "properties": { "height": 14.050003051757812, "bedlev": 724.29998779296875, "width": 60.93007025, "branchid": "river_4-1", "branchtype": "river", "branchorder": "1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_4", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386648.271799877518788, 5861347.644815167412162 ], [ 1386623.407193711958826, 5861311.520800951868296 ], [ 1386623.407193711958826, 5861176.749403670430183 ], [ 1386530.64095138432458, 5861176.749403670430183 ], [ 1386437.874709056690335, 5861041.98007211368531 ], [ 1386437.874709056690335, 5860907.212806186638772 ], [ 1386437.874709056690335, 5860772.447605801746249 ], [ 1386437.874709056690335, 5860637.684470863081515 ], [ 1386345.108466728823259, 5860502.92340128030628 ], [ 1386345.108466728823259, 5860368.164396961219609 ], [ 1386252.342224401189014, 5860233.407457816414535 ], [ 1386159.575982073554769, 5860098.652583750896156 ], [ 1386159.575982073554769, 5859963.899774673394859 ], [ 1386159.575982073554769, 5859829.149030494503677 ], [ 1386159.575982073554769, 5859694.40035112015903 ], [ 1386252.342224401189014, 5859559.653736459091306 ], [ 1386252.342224401189014, 5859424.909186420030892 ], [ 1386252.342224401189014, 5859290.166700910776854 ], [ 1386252.342224401189014, 5859155.426279840059578 ], [ 1386345.108466728823259, 5859020.687923114746809 ] ] } }, +{ "type": "Feature", "properties": { "height": 17.349960327148438, "bedlev": 701.4000244140625, "width": 60.93007025, "branchid": "river_5", "branchtype": "river", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_5", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386345.108466728823259, 5859020.687923114746809 ], [ 1386252.342224401189014, 5858885.951630645431578 ], [ 1386159.575982073554769, 5858751.217402336187661 ], [ 1386159.575982073554769, 5858616.485238100402057 ], [ 1386159.575982073554769, 5858481.755137845873833 ], [ 1386159.575982073554769, 5858347.02710147574544 ], [ 1386066.809739745920524, 5858212.301128903403878 ], [ 1385974.043497418286279, 5858212.301128903403878 ], [ 1385881.277255090652034, 5858212.301128903403878 ], [ 1385788.511012763017789, 5858212.301128903403878 ], [ 1385695.744770435383543, 5858212.301128903403878 ], [ 1385602.978528107749298, 5858077.577220032922924 ], [ 1385510.212285780115053, 5857942.855374777689576 ], [ 1385510.212285780115053, 5857808.135593040846288 ], [ 1385417.446043452480808, 5857673.41787473578006 ], [ 1385324.679801124846563, 5857673.41787473578006 ], [ 1385231.913558797212318, 5857538.702219764702022 ], [ 1385231.913558797212318, 5857403.988628041930497 ], [ 1385231.913558797212318, 5857269.277099471539259 ], [ 1385231.913558797212318, 5857134.567633965052664 ], [ 1385324.679801124846563, 5856999.86023142747581 ], [ 1385231.913558797212318, 5856865.154891769401729 ], [ 1385231.913558797212318, 5856730.451614898629487 ], [ 1385139.147316469578072, 5856595.750400722958148 ], [ 1385046.381074141710997, 5856595.750400722958148 ], [ 1384953.614831814309582, 5856461.051249152049422 ], [ 1384860.848589486675337, 5856461.051249152049422 ], [ 1384768.082347159041092, 5856326.354160091839731 ], [ 1384768.082347159041092, 5856191.659133453853428 ], [ 1384675.316104831406847, 5856056.966169144026935 ], [ 1384582.549862503772601, 5856056.966169144026935 ], [ 1384489.783620175905526, 5855922.275267072021961 ], [ 1384397.017377848271281, 5855787.586427145637572 ], [ 1384304.251135520637035, 5855787.586427145637572 ], [ 1384211.48489319300279, 5855652.899649272672832 ], [ 1384118.718650865368545, 5855518.21493336185813 ], [ 1384025.952408537967131, 5855383.532279322855175 ], [ 1383933.186166210100055, 5855248.851687061600387 ], [ 1383840.41992388246581, 5855248.851687061600387 ], [ 1383747.653681554831564, 5855114.1731564886868 ], [ 1383747.653681554831564, 5854979.496687510982156 ], [ 1383747.653681554831564, 5854844.822280039079487 ], [ 1383654.887439227197319, 5854844.822280039079487 ], [ 1383562.121196899563074, 5854710.149933977983892 ], [ 1383469.354954571928829, 5854710.149933977983892 ], [ 1383376.588712244294584, 5854575.479649240151048 ], [ 1383283.822469916660339, 5854440.811425729654729 ], [ 1383191.056227589026093, 5854440.811425729654729 ] ] } } ] } diff --git a/examples/dflowfm_piave/geoms/pipes.geojson b/examples/dflowfm_piave/geoms/pipes.geojson index a08e23fe..d17ff228 100644 --- a/examples/dflowfm_piave/geoms/pipes.geojson +++ b/examples/dflowfm_piave/geoms/pipes.geojson @@ -2,1006 +2,1006 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::3857" } }, "features": [ -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_6_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_1_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389238.298387300921604, 5860147.714495398104191 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_6_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 933.5, "invlev_up": 913.4000244140625, "invlev_dn": 931.0, "manhole_up": "manhole_1_generated", "manhole_dn": "manhole_2_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389238.298387300921604, 5860147.714495398104191 ], [ 1389210.947846550960094, 5860184.343885350972414 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_6_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.5, "elevtn_dn": 933.5, "invlev_up": 931.0, "invlev_dn": 931.0, "manhole_up": "manhole_2_generated", "manhole_dn": "manhole_3_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389210.947846550960094, 5860184.343885350972414 ], [ 1389186.961922727525234, 5860223.315261371433735 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_6_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.5, "elevtn_dn": 935.5, "invlev_up": 931.0, "invlev_dn": 933.0, "manhole_up": "manhole_3_generated", "manhole_dn": "manhole_4_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389186.961922727525234, 5860223.315261371433735 ], [ 1389162.755598766496405, 5860262.142883376218379 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_6_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 935.5, "invlev_up": 933.0, "invlev_dn": 933.0, "manhole_up": "manhole_4_generated", "manhole_dn": "manhole_5_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389162.755598766496405, 5860262.142883376218379 ], [ 1389136.759307563304901, 5860299.80301527120173 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_6_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 936.5, "invlev_up": 933.0, "invlev_dn": 934.0, "manhole_up": "manhole_5_generated", "manhole_dn": "manhole_6_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389136.759307563304901, 5860299.80301527120173 ], [ 1389109.7301227634307, 5860336.652257356792688 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_6_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 936.5, "elevtn_dn": 941.10003662109375, "invlev_up": 934.0, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_6_generated", "manhole_dn": "manhole_7_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389109.7301227634307, 5860336.652257356792688 ], [ 1389073.18478828552179, 5860363.522737024351954 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_6_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_7_generated", "manhole_dn": "manhole_8_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389073.18478828552179, 5860363.522737024351954 ], [ 1389032.546542100608349, 5860384.329287325032055 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_6_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_8_generated", "manhole_dn": "manhole_9_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389032.546542100608349, 5860384.329287325032055 ], [ 1388989.578410296700895, 5860400.071978960186243 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_6_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 951.29998779296875, "invlev_up": 938.60003662109375, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_9_generated", "manhole_dn": "manhole_10_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388989.578410296700895, 5860400.071978960186243 ], [ 1388946.301100668497384, 5860414.883977899327874 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_7_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_11_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389221.905703959986567, 5860123.3256367566064 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_7_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_11_generated", "manhole_dn": "manhole_12_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389221.905703959986567, 5860123.3256367566064 ], [ 1389177.295895804418251, 5860134.962970778346062 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_7_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 919.60003662109375, "invlev_up": 913.4000244140625, "invlev_dn": 917.10003662109375, "manhole_up": "manhole_12_generated", "manhole_dn": "manhole_13_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389177.295895804418251, 5860134.962970778346062 ], [ 1389132.686087648617104, 5860146.600304800085723 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_7_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 919.60003662109375, "elevtn_dn": 919.60003662109375, "invlev_up": 917.10003662109375, "invlev_dn": 917.10003662109375, "manhole_up": "manhole_13_generated", "manhole_dn": "manhole_14_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389132.686087648617104, 5860146.600304800085723 ], [ 1389088.076279493048787, 5860158.237638821825385 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_7_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 919.60003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 917.10003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_14_generated", "manhole_dn": "manhole_15_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389088.076279493048787, 5860158.237638821825385 ], [ 1389044.226173994829878, 5860172.143308508209884 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_7_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 935.60003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_15_generated", "manhole_dn": "manhole_16_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389044.226173994829878, 5860172.143308508209884 ], [ 1389012.527182487538084, 5860198.239755615592003 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_7_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 935.60003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_16_generated", "manhole_dn": "manhole_17_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389012.527182487538084, 5860198.239755615592003 ], [ 1388995.773122631013393, 5860240.481283166445792 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_7_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 945.0, "invlev_up": 935.60003662109375, "invlev_dn": 942.5, "manhole_up": "manhole_17_generated", "manhole_dn": "manhole_18_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388995.773122631013393, 5860240.481283166445792 ], [ 1388973.630034049740061, 5860280.918223639950156 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_7_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.0, "elevtn_dn": 951.29998779296875, "invlev_up": 942.5, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_18_generated", "manhole_dn": "manhole_19_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388973.630034049740061, 5860280.918223639950156 ], [ 1388961.171157888136804, 5860324.081192856654525 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_7_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_19_generated", "manhole_dn": "manhole_20_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388961.171157888136804, 5860324.081192856654525 ], [ 1388955.410555170848966, 5860369.690168970264494 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_7_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_20_generated", "manhole_dn": "manhole_10_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388955.410555170848966, 5860369.690168970264494 ], [ 1388946.301100668497384, 5860414.883977899327874 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 914.5, "invlev_up": 913.4000244140625, "invlev_dn": 912.0, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_21_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389306.50000010849908, 5860083.476415127515793 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 914.5, "elevtn_dn": 914.5, "invlev_up": 912.0, "invlev_dn": 912.0, "manhole_up": "manhole_21_generated", "manhole_dn": "manhole_22_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389306.50000010849908, 5860083.476415127515793 ], [ 1389355.420758404070511, 5860074.630405306816101 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 914.5, "elevtn_dn": 929.9000244140625, "invlev_up": 912.0, "invlev_dn": 927.4000244140625, "manhole_up": "manhole_22_generated", "manhole_dn": "manhole_23_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389355.420758404070511, 5860074.630405306816101 ], [ 1389389.090761042200029, 5860042.4449307853356 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 929.9000244140625, "elevtn_dn": 955.0, "invlev_up": 927.4000244140625, "invlev_dn": 952.5, "manhole_up": "manhole_23_generated", "manhole_dn": "manhole_24_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389389.090761042200029, 5860042.4449307853356 ], [ 1389404.036260401364416, 5859994.775433851405978 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_24_generated", "manhole_dn": "manhole_25_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389404.036260401364416, 5859994.775433851405978 ], [ 1389418.744130451697856, 5859947.032028519548476 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_25_generated", "manhole_dn": "manhole_26_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389418.744130451697856, 5859947.032028519548476 ], [ 1389423.265342897269875, 5859897.853969652205706 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 975.29998779296875, "invlev_up": 952.5, "invlev_dn": 972.79998779296875, "manhole_up": "manhole_26_generated", "manhole_dn": "manhole_27_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389423.265342897269875, 5859897.853969652205706 ], [ 1389395.831073811277747, 5859856.743154510855675 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 975.29998779296875, "elevtn_dn": 963.0, "invlev_up": 972.79998779296875, "invlev_dn": 960.5, "manhole_up": "manhole_27_generated", "manhole_dn": "manhole_28_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389395.831073811277747, 5859856.743154510855675 ], [ 1389350.827042841585353, 5859839.640478814020753 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 963.0, "elevtn_dn": 963.0, "invlev_up": 960.5, "invlev_dn": 960.5, "manhole_up": "manhole_28_generated", "manhole_dn": "manhole_29_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389350.827042841585353, 5859839.640478814020753 ], [ 1389303.795788601972163, 5859855.887689013034105 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 963.0, "elevtn_dn": 945.4000244140625, "invlev_up": 960.5, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_29_generated", "manhole_dn": "manhole_30_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389303.795788601972163, 5859855.887689013034105 ], [ 1389256.284586790716276, 5859863.631580747663975 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 945.4000244140625, "invlev_up": 942.9000244140625, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_30_generated", "manhole_dn": "manhole_31_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389256.284586790716276, 5859863.631580747663975 ], [ 1389227.308454349869862, 5859823.781623384915292 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 945.4000244140625, "invlev_up": 942.9000244140625, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_31_generated", "manhole_dn": "manhole_32_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389227.308454349869862, 5859823.781623384915292 ], [ 1389202.745489193825051, 5859780.279727600514889 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 959.10003662109375, "invlev_up": 942.9000244140625, "invlev_dn": 956.60003662109375, "manhole_up": "manhole_32_generated", "manhole_dn": "manhole_33_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389202.745489193825051, 5859780.279727600514889 ], [ 1389178.18252403778024, 5859736.777831817045808 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 959.10003662109375, "elevtn_dn": 944.79998779296875, "invlev_up": 956.60003662109375, "invlev_dn": 942.29998779296875, "manhole_up": "manhole_33_generated", "manhole_dn": "manhole_34_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389178.18252403778024, 5859736.777831817045808 ], [ 1389155.231297271326184, 5859692.450142606161535 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 944.79998779296875, "elevtn_dn": 944.79998779296875, "invlev_up": 942.29998779296875, "invlev_dn": 942.29998779296875, "manhole_up": "manhole_34_generated", "manhole_dn": "manhole_35_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389155.231297271326184, 5859692.450142606161535 ], [ 1389141.413412723457441, 5859644.883844587020576 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 944.79998779296875, "elevtn_dn": 952.4000244140625, "invlev_up": 942.29998779296875, "invlev_dn": 949.9000244140625, "manhole_up": "manhole_35_generated", "manhole_dn": "manhole_36_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389141.413412723457441, 5859644.883844587020576 ], [ 1389151.802280035568401, 5859598.61804121825844 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.4000244140625, "elevtn_dn": 960.70001220703125, "invlev_up": 949.9000244140625, "invlev_dn": 958.20001220703125, "manhole_up": "manhole_36_generated", "manhole_dn": "manhole_37_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389151.802280035568401, 5859598.61804121825844 ], [ 1389191.073854762827978, 5859569.046822287142277 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 960.70001220703125, "elevtn_dn": 960.70001220703125, "invlev_up": 958.20001220703125, "invlev_dn": 958.20001220703125, "manhole_up": "manhole_37_generated", "manhole_dn": "manhole_38_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389191.073854762827978, 5859569.046822287142277 ], [ 1389239.915165816899389, 5859563.955490378662944 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 960.70001220703125, "elevtn_dn": 969.60003662109375, "invlev_up": 958.20001220703125, "invlev_dn": 967.10003662109375, "manhole_up": "manhole_38_generated", "manhole_dn": "manhole_39_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389239.915165816899389, 5859563.955490378662944 ], [ 1389289.757686472963542, 5859566.285022127442062 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 969.60003662109375, "elevtn_dn": 969.60003662109375, "invlev_up": 967.10003662109375, "invlev_dn": 967.10003662109375, "manhole_up": "manhole_39_generated", "manhole_dn": "manhole_40_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389289.757686472963542, 5859566.285022127442062 ], [ 1389339.615828452631831, 5859566.079234052449465 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 969.60003662109375, "elevtn_dn": 976.29998779296875, "invlev_up": 967.10003662109375, "invlev_dn": 973.79998779296875, "manhole_up": "manhole_40_generated", "manhole_dn": "manhole_41_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389339.615828452631831, 5859566.079234052449465 ], [ 1389387.354307833593339, 5859551.676988741382957 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 976.29998779296875, "elevtn_dn": 976.29998779296875, "invlev_up": 973.79998779296875, "invlev_dn": 973.79998779296875, "manhole_up": "manhole_41_generated", "manhole_dn": "manhole_42_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389387.354307833593339, 5859551.676988741382957 ], [ 1389428.692968821851537, 5859524.248876142315567 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 976.29998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 973.79998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_42_generated", "manhole_dn": "manhole_43_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389428.692968821851537, 5859524.248876142315567 ], [ 1389461.138921525795013, 5859486.477508954703808 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_43_generated", "manhole_dn": "manhole_44_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389461.138921525795013, 5859486.477508954703808 ], [ 1389482.45163832209073, 5859441.487986368127167 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_44_generated", "manhole_dn": "manhole_45_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389482.45163832209073, 5859441.487986368127167 ], [ 1389497.215460168197751, 5859393.906833835877478 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_45_generated", "manhole_dn": "manhole_46_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389497.215460168197751, 5859393.906833835877478 ], [ 1389508.394423164660111, 5859345.216126504354179 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 954.79998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_46_generated", "manhole_dn": "manhole_47_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389508.394423164660111, 5859345.216126504354179 ], [ 1389518.522437864448875, 5859296.29671473056078 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 954.79998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_47_generated", "manhole_dn": "manhole_48_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389518.522437864448875, 5859296.29671473056078 ], [ 1389528.588071504374966, 5859247.363727764226496 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 950.20001220703125, "invlev_up": 954.79998779296875, "invlev_dn": 947.70001220703125, "manhole_up": "manhole_48_generated", "manhole_dn": "manhole_49_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389528.588071504374966, 5859247.363727764226496 ], [ 1389538.653705144301057, 5859198.43074079696089 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 950.20001220703125, "elevtn_dn": 957.60003662109375, "invlev_up": 947.70001220703125, "invlev_dn": 955.10003662109375, "manhole_up": "manhole_49_generated", "manhole_dn": "manhole_50_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389538.653705144301057, 5859198.43074079696089 ], [ 1389548.719338784459978, 5859149.497753830626607 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.60003662109375, "elevtn_dn": 957.60003662109375, "invlev_up": 955.10003662109375, "invlev_dn": 955.10003662109375, "manhole_up": "manhole_50_generated", "manhole_dn": "manhole_51_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389548.719338784459978, 5859149.497753830626607 ], [ 1389558.784972424386069, 5859100.564766863361001 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.60003662109375, "elevtn_dn": 954.79998779296875, "invlev_up": 955.10003662109375, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_51_generated", "manhole_dn": "manhole_52_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389558.784972424386069, 5859100.564766863361001 ], [ 1389568.85060606431216, 5859051.631779897026718 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 954.79998779296875, "invlev_up": 952.29998779296875, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_52_generated", "manhole_dn": "manhole_53_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389568.85060606431216, 5859051.631779897026718 ], [ 1389578.916239704471081, 5859002.698792929761112 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 954.79998779296875, "invlev_up": 952.29998779296875, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_53_generated", "manhole_dn": "manhole_54_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389578.916239704471081, 5859002.698792929761112 ], [ 1389588.981873344397172, 5858953.765805963426828 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 956.10003662109375, "invlev_up": 952.29998779296875, "invlev_dn": 953.60003662109375, "manhole_up": "manhole_54_generated", "manhole_dn": "manhole_55_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389588.981873344397172, 5858953.765805963426828 ], [ 1389599.047506984323263, 5858904.832818996161222 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 956.10003662109375, "elevtn_dn": 956.10003662109375, "invlev_up": 953.60003662109375, "invlev_dn": 953.60003662109375, "manhole_up": "manhole_55_generated", "manhole_dn": "manhole_56_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389599.047506984323263, 5858904.832818996161222 ], [ 1389613.243873829254881, 5858857.048414096236229 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 956.10003662109375, "elevtn_dn": 966.29998779296875, "invlev_up": 953.60003662109375, "invlev_dn": 963.79998779296875, "manhole_up": "manhole_56_generated", "manhole_dn": "manhole_57_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389613.243873829254881, 5858857.048414096236229 ], [ 1389631.198101107496768, 5858810.554778259247541 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 966.29998779296875, "elevtn_dn": 968.70001220703125, "invlev_up": 963.79998779296875, "invlev_dn": 966.20001220703125, "manhole_up": "manhole_57_generated", "manhole_dn": "manhole_58_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389631.198101107496768, 5858810.554778259247541 ], [ 1389656.490605737781152, 5858767.472956065088511 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.70001220703125, "elevtn_dn": 968.70001220703125, "invlev_up": 966.20001220703125, "invlev_dn": 966.20001220703125, "manhole_up": "manhole_58_generated", "manhole_dn": "manhole_59_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389656.490605737781152, 5858767.472956065088511 ], [ 1389681.956975018838421, 5858724.49639992788434 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.70001220703125, "elevtn_dn": 976.10003662109375, "invlev_up": 966.20001220703125, "invlev_dn": 973.60003662109375, "manhole_up": "manhole_59_generated", "manhole_dn": "manhole_60_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389681.956975018838421, 5858724.49639992788434 ], [ 1389708.407580326776952, 5858682.115747822448611 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 976.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 973.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_60_generated", "manhole_dn": "manhole_61_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389708.407580326776952, 5858682.115747822448611 ], [ 1389734.858185634715483, 5858639.735095717012882 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 980.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_61_generated", "manhole_dn": "manhole_62_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389734.858185634715483, 5858639.735095717012882 ], [ 1389761.308790942654014, 5858597.354443610645831 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 980.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_62_generated", "manhole_dn": "manhole_63_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389761.308790942654014, 5858597.354443610645831 ], [ 1389787.759396250825375, 5858554.973791505210102 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 993.29998779296875, "invlev_up": 980.60003662109375, "invlev_dn": 990.79998779296875, "manhole_up": "manhole_63_generated", "manhole_dn": "manhole_64_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389787.759396250825375, 5858554.973791505210102 ], [ 1389814.210001558763906, 5858512.593139399774373 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 993.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 990.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_64_generated", "manhole_dn": "manhole_65_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389814.210001558763906, 5858512.593139399774373 ], [ 1389840.660606866702437, 5858470.212487293407321 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 995.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_65_generated", "manhole_dn": "manhole_66_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389840.660606866702437, 5858470.212487293407321 ], [ 1389867.111212174640968, 5858427.831835187971592 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 995.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_66_generated", "manhole_dn": "manhole_67_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389867.111212174640968, 5858427.831835187971592 ], [ 1389911.240854029776528, 5858417.074701879173517 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 1006.2000122070312, "invlev_up": 995.79998779296875, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_67_generated", "manhole_dn": "manhole_68_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389911.240854029776528, 5858417.074701879173517 ], [ 1389940.226093058940023, 5858455.739661679603159 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E48", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1006.2000122070312, "invlev_up": 1003.7000122070312, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_68_generated", "manhole_dn": "manhole_69_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389940.226093058940023, 5858455.739661679603159 ], [ 1389959.842267287895083, 5858501.684845351614058 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E49", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1006.2000122070312, "invlev_up": 1003.7000122070312, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_69_generated", "manhole_dn": "manhole_70_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389959.842267287895083, 5858501.684845351614058 ], [ 1389983.028926897095516, 5858544.760824581608176 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E50", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1036.9000244140625, "invlev_up": 1003.7000122070312, "invlev_dn": 1034.4000244140625, "manhole_up": "manhole_70_generated", "manhole_dn": "manhole_71_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389983.028926897095516, 5858544.760824581608176 ], [ 1390026.879799408372492, 5858567.986969069577754 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E51", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1036.9000244140625, "elevtn_dn": 1036.9000244140625, "invlev_up": 1034.4000244140625, "invlev_dn": 1034.4000244140625, "manhole_up": "manhole_71_generated", "manhole_dn": "manhole_72_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390026.879799408372492, 5858567.986969069577754 ], [ 1390075.455719914287329, 5858577.981817713007331 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E52", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1036.9000244140625, "elevtn_dn": 1032.9000244140625, "invlev_up": 1034.4000244140625, "invlev_dn": 1030.4000244140625, "manhole_up": "manhole_72_generated", "manhole_dn": "manhole_73_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390075.455719914287329, 5858577.981817713007331 ], [ 1390124.934819511603564, 5858584.860858413390815 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E53", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1032.9000244140625, "elevtn_dn": 1032.9000244140625, "invlev_up": 1030.4000244140625, "invlev_dn": 1030.4000244140625, "manhole_up": "manhole_73_generated", "manhole_dn": "manhole_74_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390124.934819511603564, 5858584.860858413390815 ], [ 1390174.385966305155307, 5858591.894069475121796 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E54", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1032.9000244140625, "elevtn_dn": 1016.6000366210938, "invlev_up": 1030.4000244140625, "invlev_dn": 1014.1000366210938, "manhole_up": "manhole_74_generated", "manhole_dn": "manhole_75_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390174.385966305155307, 5858591.894069475121796 ], [ 1390224.28731826832518, 5858594.262458441779017 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E55", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1016.6000366210938, "elevtn_dn": 1016.6000366210938, "invlev_up": 1014.1000366210938, "invlev_dn": 1014.1000366210938, "manhole_up": "manhole_75_generated", "manhole_dn": "manhole_76_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390224.28731826832518, 5858594.262458441779017 ], [ 1390273.630285855382681, 5858589.561945637688041 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E56", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1016.6000366210938, "elevtn_dn": 1012.1000366210938, "invlev_up": 1014.1000366210938, "invlev_dn": 1009.6000366210938, "manhole_up": "manhole_76_generated", "manhole_dn": "manhole_77_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390273.630285855382681, 5858589.561945637688041 ], [ 1390322.239480242831632, 5858578.072306710295379 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E57", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1012.1000366210938, "elevtn_dn": 1012.1000366210938, "invlev_up": 1009.6000366210938, "invlev_dn": 1009.6000366210938, "manhole_up": "manhole_77_generated", "manhole_dn": "manhole_78_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390322.239480242831632, 5858578.072306710295379 ], [ 1390371.99352877959609, 5858575.309522898867726 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E58", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1012.1000366210938, "elevtn_dn": 1011.7000122070312, "invlev_up": 1009.6000366210938, "invlev_dn": 1009.2000122070312, "manhole_up": "manhole_78_generated", "manhole_dn": "manhole_79_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390371.99352877959609, 5858575.309522898867726 ], [ 1390419.13544210139662, 5858559.59311543405056 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E59", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1011.7000122070312, "elevtn_dn": 981.5, "invlev_up": 1009.2000122070312, "invlev_dn": 979.0, "manhole_up": "manhole_79_generated", "manhole_dn": "manhole_80_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390419.13544210139662, 5858559.59311543405056 ], [ 1390453.401623640675098, 5858524.246223840862513 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E60", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 981.5, "elevtn_dn": 995.70001220703125, "invlev_up": 979.0, "invlev_dn": 993.20001220703125, "manhole_up": "manhole_80_generated", "manhole_dn": "manhole_81_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390453.401623640675098, 5858524.246223840862513 ], [ 1390496.749499944737181, 5858504.780008735135198 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E61", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 995.70001220703125, "elevtn_dn": 995.70001220703125, "invlev_up": 993.20001220703125, "invlev_dn": 993.20001220703125, "manhole_up": "manhole_81_generated", "manhole_dn": "manhole_82_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390496.749499944737181, 5858504.780008735135198 ], [ 1390546.470755147282034, 5858499.993151630274951 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E62", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 995.70001220703125, "elevtn_dn": 1005.9000244140625, "invlev_up": 993.20001220703125, "invlev_dn": 1003.4000244140625, "manhole_up": "manhole_82_generated", "manhole_dn": "manhole_83_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390546.470755147282034, 5858499.993151630274951 ], [ 1390596.395264241611585, 5858498.177226040512323 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E63", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1005.9000244140625, "elevtn_dn": 1005.9000244140625, "invlev_up": 1003.4000244140625, "invlev_dn": 1003.4000244140625, "manhole_up": "manhole_83_generated", "manhole_dn": "manhole_84_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390596.395264241611585, 5858498.177226040512323 ], [ 1390646.319773336173967, 5858496.361300451681018 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E64", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1005.9000244140625, "elevtn_dn": 1013.6000366210938, "invlev_up": 1003.4000244140625, "invlev_dn": 1011.1000366210938, "manhole_up": "manhole_84_generated", "manhole_dn": "manhole_85_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390646.319773336173967, 5858496.361300451681018 ], [ 1390696.244282430503517, 5858494.545374862849712 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E65", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1013.6000366210938, "elevtn_dn": 1013.6000366210938, "invlev_up": 1011.1000366210938, "invlev_dn": 1011.1000366210938, "manhole_up": "manhole_85_generated", "manhole_dn": "manhole_86_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390696.244282430503517, 5858494.545374862849712 ], [ 1390746.168791524833068, 5858492.729449273087084 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E66", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1013.6000366210938, "elevtn_dn": 1019.1000366210938, "invlev_up": 1011.1000366210938, "invlev_dn": 1016.6000366210938, "manhole_up": "manhole_86_generated", "manhole_dn": "manhole_87_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390746.168791524833068, 5858492.729449273087084 ], [ 1390796.09330061939545, 5858490.913523684255779 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E67", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1019.1000366210938, "elevtn_dn": 1025.800048828125, "invlev_up": 1016.6000366210938, "invlev_dn": 1023.300048828125, "manhole_up": "manhole_87_generated", "manhole_dn": "manhole_88_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390796.09330061939545, 5858490.913523684255779 ], [ 1390846.017809713725001, 5858489.097598095424473 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E68", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1025.800048828125, "elevtn_dn": 1025.800048828125, "invlev_up": 1023.300048828125, "invlev_dn": 1023.300048828125, "manhole_up": "manhole_88_generated", "manhole_dn": "manhole_89_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390846.017809713725001, 5858489.097598095424473 ], [ 1390895.942318808054551, 5858487.281672505661845 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E69", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1025.800048828125, "elevtn_dn": 1029.2000732421875, "invlev_up": 1023.300048828125, "invlev_dn": 1026.7000732421875, "manhole_up": "manhole_89_generated", "manhole_dn": "manhole_90_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390895.942318808054551, 5858487.281672505661845 ], [ 1390945.364988021552563, 5858492.061225635930896 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E70", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1029.2000732421875, "elevtn_dn": 1029.2000732421875, "invlev_up": 1026.7000732421875, "invlev_dn": 1026.7000732421875, "manhole_up": "manhole_90_generated", "manhole_dn": "manhole_91_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390945.364988021552563, 5858492.061225635930896 ], [ 1390994.440001817885786, 5858501.409873396158218 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E71", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1029.2000732421875, "elevtn_dn": 1033.2000732421875, "invlev_up": 1026.7000732421875, "invlev_dn": 1030.7000732421875, "manhole_up": "manhole_91_generated", "manhole_dn": "manhole_92_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390994.440001817885786, 5858501.409873396158218 ], [ 1391040.341196772176772, 5858520.979841153137386 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E72", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1033.2000732421875, "elevtn_dn": 1033.2000732421875, "invlev_up": 1030.7000732421875, "invlev_dn": 1030.7000732421875, "manhole_up": "manhole_92_generated", "manhole_dn": "manhole_93_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391040.341196772176772, 5858520.979841153137386 ], [ 1391086.683747049886733, 5858538.717575071379542 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E73", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1033.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1030.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_93_generated", "manhole_dn": "manhole_94_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391086.683747049886733, 5858538.717575071379542 ], [ 1391131.822940095094964, 5858523.93243224080652 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E74", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_94_generated", "manhole_dn": "manhole_95_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391131.822940095094964, 5858523.93243224080652 ], [ 1391153.157672074623406, 5858479.460670891217887 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E75", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_95_generated", "manhole_dn": "manhole_96_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391153.157672074623406, 5858479.460670891217887 ], [ 1391192.49590603238903, 5858451.67839205916971 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E76", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1044.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1041.7000732421875, "manhole_up": "manhole_96_generated", "manhole_dn": "manhole_97_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391192.49590603238903, 5858451.67839205916971 ], [ 1391240.64117361814715, 5858438.460245226509869 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E77", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1044.2000732421875, "elevtn_dn": 1044.2000732421875, "invlev_up": 1041.7000732421875, "invlev_dn": 1041.7000732421875, "manhole_up": "manhole_97_generated", "manhole_dn": "manhole_98_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391240.64117361814715, 5858438.460245226509869 ], [ 1391289.211760010803118, 5858426.770406410098076 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E78", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1044.2000732421875, "elevtn_dn": 1060.0999755859375, "invlev_up": 1041.7000732421875, "invlev_dn": 1057.5999755859375, "manhole_up": "manhole_98_generated", "manhole_dn": "manhole_99_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391289.211760010803118, 5858426.770406410098076 ], [ 1391337.782346403226256, 5858415.080567593686283 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E79", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1060.0999755859375, "elevtn_dn": 1023.0, "invlev_up": 1057.5999755859375, "invlev_dn": 1020.5, "manhole_up": "manhole_99_generated", "manhole_dn": "manhole_100_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391337.782346403226256, 5858415.080567593686283 ], [ 1391386.352932795882225, 5858403.390728777274489 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E80", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1023.0, "elevtn_dn": 1032.7000732421875, "invlev_up": 1020.5, "invlev_dn": 1030.2000732421875, "manhole_up": "manhole_100_generated", "manhole_dn": "manhole_101_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391386.352932795882225, 5858403.390728777274489 ], [ 1391434.923519188305363, 5858391.700889961794019 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E81", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1032.7000732421875, "elevtn_dn": 1032.7000732421875, "invlev_up": 1030.2000732421875, "invlev_dn": 1030.2000732421875, "manhole_up": "manhole_101_generated", "manhole_dn": "manhole_102_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391434.923519188305363, 5858391.700889961794019 ], [ 1391483.494105580961332, 5858380.011051145382226 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E82", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1032.7000732421875, "elevtn_dn": 1040.7000732421875, "invlev_up": 1030.2000732421875, "invlev_dn": 1038.2000732421875, "manhole_up": "manhole_102_generated", "manhole_dn": "manhole_103_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391483.494105580961332, 5858380.011051145382226 ], [ 1391532.464345134794712, 5858375.802092345431447 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E83", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1040.7000732421875, "elevtn_dn": 1040.7000732421875, "invlev_up": 1038.2000732421875, "invlev_dn": 1038.2000732421875, "manhole_up": "manhole_103_generated", "manhole_dn": "manhole_104_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391532.464345134794712, 5858375.802092345431447 ], [ 1391579.680508555145934, 5858389.753166117705405 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E84", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1040.7000732421875, "elevtn_dn": 1094.5999755859375, "invlev_up": 1038.2000732421875, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_104_generated", "manhole_dn": "manhole_105_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391579.680508555145934, 5858389.753166117705405 ], [ 1391615.043221722124144, 5858422.374543751589954 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E85", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1094.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_105_generated", "manhole_dn": "manhole_106_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391615.043221722124144, 5858422.374543751589954 ], [ 1391633.654095822479576, 5858468.206737855449319 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E86", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1094.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_106_generated", "manhole_dn": "manhole_107_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391633.654095822479576, 5858468.206737855449319 ], [ 1391675.556871910346672, 5858492.042518986389041 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E87", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1100.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1098.0999755859375, "manhole_up": "manhole_107_generated", "manhole_dn": "manhole_108_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391675.556871910346672, 5858492.042518986389041 ], [ 1391725.165284683462232, 5858493.223410680890083 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E88", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1100.5999755859375, "elevtn_dn": 1092.7000732421875, "invlev_up": 1098.0999755859375, "invlev_dn": 1090.2000732421875, "manhole_up": "manhole_108_generated", "manhole_dn": "manhole_109_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391725.165284683462232, 5858493.223410680890083 ], [ 1391774.025632579578087, 5858482.968163449317217 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E89", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1092.7000732421875, "elevtn_dn": 1092.7000732421875, "invlev_up": 1090.2000732421875, "invlev_dn": 1090.2000732421875, "manhole_up": "manhole_109_generated", "manhole_dn": "manhole_110_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391774.025632579578087, 5858482.968163449317217 ], [ 1391822.748904443578795, 5858472.800456050783396 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E90", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1092.7000732421875, "elevtn_dn": 1086.5, "invlev_up": 1090.2000732421875, "invlev_dn": 1084.0, "manhole_up": "manhole_110_generated", "manhole_dn": "manhole_111_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391822.748904443578795, 5858472.800456050783396 ], [ 1391872.520155652426183, 5858474.254766616038978 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E91", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1086.5, "elevtn_dn": 1086.5, "invlev_up": 1084.0, "invlev_dn": 1084.0, "manhole_up": "manhole_111_generated", "manhole_dn": "manhole_112_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391872.520155652426183, 5858474.254766616038978 ], [ 1391922.32820742437616, 5858478.116394865326583 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E92", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1086.5, "elevtn_dn": 1097.300048828125, "invlev_up": 1084.0, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_112_generated", "manhole_dn": "manhole_113_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391922.32820742437616, 5858478.116394865326583 ], [ 1391972.136259196558967, 5858481.978023114614189 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E93", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_113_generated", "manhole_dn": "manhole_114_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391972.136259196558967, 5858481.978023114614189 ], [ 1392014.088137687649578, 5858507.265420926734805 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E94", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_114_generated", "manhole_dn": "manhole_115_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392014.088137687649578, 5858507.265420926734805 ], [ 1392052.00577615830116, 5858538.949620860628784 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E95", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_115_generated", "manhole_dn": "manhole_116_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392052.00577615830116, 5858538.949620860628784 ], [ 1392100.993319420609623, 5858548.746293722651899 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E96", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1135.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1132.800048828125, "manhole_up": "manhole_116_generated", "manhole_dn": "manhole_117_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392100.993319420609623, 5858548.746293722651899 ], [ 1392149.980862683150917, 5858558.542966585606337 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E97", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1135.300048828125, "elevtn_dn": 1135.300048828125, "invlev_up": 1132.800048828125, "invlev_dn": 1132.800048828125, "manhole_up": "manhole_117_generated", "manhole_dn": "manhole_118_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392149.980862683150917, 5858558.542966585606337 ], [ 1392198.767287699971348, 5858569.25206732749939 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E98", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1135.300048828125, "elevtn_dn": 1137.5999755859375, "invlev_up": 1132.800048828125, "invlev_dn": 1135.0999755859375, "manhole_up": "manhole_118_generated", "manhole_dn": "manhole_119_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392198.767287699971348, 5858569.25206732749939 ], [ 1392247.333906656363979, 5858580.958378325216472 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E99", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1137.5999755859375, "elevtn_dn": 1137.5999755859375, "invlev_up": 1135.0999755859375, "invlev_dn": 1135.0999755859375, "manhole_up": "manhole_119_generated", "manhole_dn": "manhole_120_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392247.333906656363979, 5858580.958378325216472 ], [ 1392295.900525612989441, 5858592.664689323864877 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E100", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1137.5999755859375, "elevtn_dn": 1145.0999755859375, "invlev_up": 1135.0999755859375, "invlev_dn": 1142.5999755859375, "manhole_up": "manhole_120_generated", "manhole_dn": "manhole_121_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392295.900525612989441, 5858592.664689323864877 ], [ 1392344.467144569614902, 5858604.371000322513282 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E101", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1145.0999755859375, "elevtn_dn": 1145.0999755859375, "invlev_up": 1142.5999755859375, "invlev_dn": 1142.5999755859375, "manhole_up": "manhole_121_generated", "manhole_dn": "manhole_122_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392344.467144569614902, 5858604.371000322513282 ], [ 1392389.908255772199482, 5858624.575613909401 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E102", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1145.0999755859375, "elevtn_dn": 1140.5, "invlev_up": 1142.5999755859375, "invlev_dn": 1138.0, "manhole_up": "manhole_122_generated", "manhole_dn": "manhole_123_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392389.908255772199482, 5858624.575613909401 ], [ 1392425.081700494978577, 5858659.315580372698605 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E103", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1140.5, "elevtn_dn": 1169.300048828125, "invlev_up": 1138.0, "invlev_dn": 1166.800048828125, "manhole_up": "manhole_123_generated", "manhole_dn": "manhole_124_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392425.081700494978577, 5858659.315580372698605 ], [ 1392458.203119478421286, 5858696.715123130939901 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E104", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.300048828125, "elevtn_dn": 1169.300048828125, "invlev_up": 1166.800048828125, "invlev_dn": 1166.800048828125, "manhole_up": "manhole_124_generated", "manhole_dn": "manhole_125_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392458.203119478421286, 5858696.715123130939901 ], [ 1392491.324538461863995, 5858734.114665890112519 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E105", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.300048828125, "elevtn_dn": 1165.5, "invlev_up": 1166.800048828125, "invlev_dn": 1163.0, "manhole_up": "manhole_125_generated", "manhole_dn": "manhole_126_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392491.324538461863995, 5858734.114665890112519 ], [ 1392528.963966277893633, 5858766.460637149401009 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E106", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1165.5, "elevtn_dn": 1165.5, "invlev_up": 1163.0, "invlev_dn": 1163.0, "manhole_up": "manhole_126_generated", "manhole_dn": "manhole_127_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392528.963966277893633, 5858766.460637149401009 ], [ 1392573.284122244687751, 5858789.391092935577035 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E107", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1165.5, "elevtn_dn": 1157.0999755859375, "invlev_up": 1163.0, "invlev_dn": 1154.5999755859375, "manhole_up": "manhole_127_generated", "manhole_dn": "manhole_128_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392573.284122244687751, 5858789.391092935577035 ], [ 1392618.033192394766957, 5858811.600886153057218 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E108", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1157.0999755859375, "elevtn_dn": 1184.800048828125, "invlev_up": 1154.5999755859375, "invlev_dn": 1182.300048828125, "manhole_up": "manhole_128_generated", "manhole_dn": "manhole_129_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392618.033192394766957, 5858811.600886153057218 ], [ 1392666.730896146036685, 5858821.011833874508739 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E109", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1184.800048828125, "elevtn_dn": 1141.2000732421875, "invlev_up": 1182.300048828125, "invlev_dn": 1138.7000732421875, "manhole_up": "manhole_129_generated", "manhole_dn": "manhole_130_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392666.730896146036685, 5858821.011833874508739 ], [ 1392714.397227015113458, 5858809.184477739967406 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E110", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1141.2000732421875, "elevtn_dn": 1141.2000732421875, "invlev_up": 1138.7000732421875, "invlev_dn": 1138.7000732421875, "manhole_up": "manhole_130_generated", "manhole_dn": "manhole_131_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392714.397227015113458, 5858809.184477739967406 ], [ 1392761.799294820055366, 5858794.231293976306915 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E111", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1141.2000732421875, "elevtn_dn": 1137.4000244140625, "invlev_up": 1138.7000732421875, "invlev_dn": 1134.9000244140625, "manhole_up": "manhole_131_generated", "manhole_dn": "manhole_132_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392761.799294820055366, 5858794.231293976306915 ], [ 1392810.095712865469977, 5858797.830352782271802 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E112", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1137.4000244140625, "elevtn_dn": 1137.4000244140625, "invlev_up": 1134.9000244140625, "invlev_dn": 1134.9000244140625, "manhole_up": "manhole_132_generated", "manhole_dn": "manhole_133_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392810.095712865469977, 5858797.830352782271802 ], [ 1392855.660074200481176, 5858817.529770986177027 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E113", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1137.4000244140625, "elevtn_dn": 1169.5, "invlev_up": 1134.9000244140625, "invlev_dn": 1167.0, "manhole_up": "manhole_133_generated", "manhole_dn": "manhole_134_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392855.660074200481176, 5858817.529770986177027 ], [ 1392904.672455, 5858826.347064822912216 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E114", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_134_generated", "manhole_dn": "manhole_135_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392904.672455, 5858826.347064822912216 ], [ 1392949.505032581742853, 5858846.393358059227467 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E115", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_135_generated", "manhole_dn": "manhole_136_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392949.505032581742853, 5858846.393358059227467 ], [ 1392993.956312821945176, 5858868.358838438987732 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E116", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_136_generated", "manhole_dn": "manhole_137_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392993.956312821945176, 5858868.358838438987732 ], [ 1393042.160067020915449, 5858881.479519641026855 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E117", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1162.0, "invlev_up": 1167.0, "invlev_dn": 1159.5, "manhole_up": "manhole_137_generated", "manhole_dn": "manhole_138_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393042.160067020915449, 5858881.479519641026855 ], [ 1393090.363821219652891, 5858894.600200843065977 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E118", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1162.0, "elevtn_dn": 1162.0, "invlev_up": 1159.5, "invlev_dn": 1159.5, "manhole_up": "manhole_138_generated", "manhole_dn": "manhole_139_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393090.363821219652891, 5858894.600200843065977 ], [ 1393138.877780271228403, 5858905.382868006825447 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E119", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1162.0, "elevtn_dn": 1152.0999755859375, "invlev_up": 1159.5, "invlev_dn": 1149.5999755859375, "manhole_up": "manhole_139_generated", "manhole_dn": "manhole_140_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393138.877780271228403, 5858905.382868006825447 ], [ 1393188.835210436256602, 5858905.286093098111451 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E120", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1152.0999755859375, "elevtn_dn": 1152.0999755859375, "invlev_up": 1149.5999755859375, "invlev_dn": 1149.5999755859375, "manhole_up": "manhole_140_generated", "manhole_dn": "manhole_141_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393188.835210436256602, 5858905.286093098111451 ], [ 1393237.248238409170881, 5858916.599204055964947 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E121", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1152.0999755859375, "elevtn_dn": 1147.300048828125, "invlev_up": 1149.5999755859375, "invlev_dn": 1144.800048828125, "manhole_up": "manhole_141_generated", "manhole_dn": "manhole_142_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393237.248238409170881, 5858916.599204055964947 ], [ 1393278.15638761385344, 5858943.766047672368586 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E122", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1147.300048828125, "elevtn_dn": 1182.7000732421875, "invlev_up": 1144.800048828125, "invlev_dn": 1180.2000732421875, "manhole_up": "manhole_142_generated", "manhole_dn": "manhole_143_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393278.15638761385344, 5858943.766047672368586 ], [ 1393316.553906054003164, 5858975.725158606655896 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E123", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1182.7000732421875, "elevtn_dn": 1180.0999755859375, "invlev_up": 1180.2000732421875, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_143_generated", "manhole_dn": "manhole_144_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393316.553906054003164, 5858975.725158606655896 ], [ 1393354.951424494385719, 5859007.684269540011883 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E124", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1180.0999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_144_generated", "manhole_dn": "manhole_145_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393354.951424494385719, 5859007.684269540011883 ], [ 1393393.348942934535444, 5859039.643380474299192 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E125", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1180.0999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_145_generated", "manhole_dn": "manhole_146_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393393.348942934535444, 5859039.643380474299192 ], [ 1393431.746461374685168, 5859071.602491408586502 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E126", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_146_generated", "manhole_dn": "manhole_147_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393431.746461374685168, 5859071.602491408586502 ], [ 1393472.672340910183266, 5859100.089053857140243 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E127", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1200.0999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_147_generated", "manhole_dn": "manhole_148_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393472.672340910183266, 5859100.089053857140243 ], [ 1393507.678647378925234, 5859134.262682756409049 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E128", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1200.0999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_148_generated", "manhole_dn": "manhole_149_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393507.678647378925234, 5859134.262682756409049 ], [ 1393492.637579936999828, 5859179.667013085447252 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E129", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1232.300048828125, "invlev_up": 1200.0999755859375, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_149_generated", "manhole_dn": "manhole_150_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393492.637579936999828, 5859179.667013085447252 ], [ 1393472.727902054553851, 5859225.064155456610024 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E130", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_150_generated", "manhole_dn": "manhole_151_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393472.727902054553851, 5859225.064155456610024 ], [ 1393467.563765458529815, 5859274.587596206925809 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E131", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_151_generated", "manhole_dn": "manhole_152_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393467.563765458529815, 5859274.587596206925809 ], [ 1393473.51405850565061, 5859323.8850102070719 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E132", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_152_generated", "manhole_dn": "manhole_153_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393473.51405850565061, 5859323.8850102070719 ], [ 1393507.773820924572647, 5859356.614802500233054 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E133", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1214.800048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1212.300048828125, "manhole_up": "manhole_153_generated", "manhole_dn": "manhole_154_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393507.773820924572647, 5859356.614802500233054 ], [ 1393555.824224345618859, 5859349.253152369521558 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E134", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1214.800048828125, "elevtn_dn": 1214.800048828125, "invlev_up": 1212.300048828125, "invlev_dn": 1212.300048828125, "manhole_up": "manhole_154_generated", "manhole_dn": "manhole_155_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393555.824224345618859, 5859349.253152369521558 ], [ 1393591.00338595919311, 5859314.794959847815335 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E135", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1214.800048828125, "elevtn_dn": 1191.0999755859375, "invlev_up": 1212.300048828125, "invlev_dn": 1188.5999755859375, "manhole_up": "manhole_155_generated", "manhole_dn": "manhole_156_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393591.00338595919311, 5859314.794959847815335 ], [ 1393633.153639519121498, 5859288.066565420478582 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E136", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1191.0999755859375, "elevtn_dn": 1191.0999755859375, "invlev_up": 1188.5999755859375, "invlev_dn": 1188.5999755859375, "manhole_up": "manhole_156_generated", "manhole_dn": "manhole_157_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393633.153639519121498, 5859288.066565420478582 ], [ 1393673.123904188396409, 5859258.097712650895119 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E137", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1191.0999755859375, "elevtn_dn": 1144.300048828125, "invlev_up": 1188.5999755859375, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_157_generated", "manhole_dn": "manhole_158_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393673.123904188396409, 5859258.097712650895119 ], [ 1393720.523227575467899, 5859244.838272913359106 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E138", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1144.300048828125, "invlev_up": 1141.800048828125, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_158_generated", "manhole_dn": "manhole_159_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393720.523227575467899, 5859244.838272913359106 ], [ 1393765.710014625452459, 5859224.569284616038203 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E139", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1144.300048828125, "invlev_up": 1141.800048828125, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_159_generated", "manhole_dn": "manhole_160_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393765.710014625452459, 5859224.569284616038203 ], [ 1393806.409210936399177, 5859195.609256223775446 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_8_E140", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1112.5, "invlev_up": 1141.800048828125, "invlev_dn": 1110.0, "manhole_up": "manhole_160_generated", "manhole_dn": "manhole_161_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393806.409210936399177, 5859195.609256223775446 ], [ 1393846.866742686368525, 5859166.301538489758968 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1045", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 968.29998779296875, "invlev_up": 965.79998779296875, "invlev_dn": 965.79998779296875, "manhole_up": "manhole_162_generated", "manhole_dn": "manhole_163_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388521.257592596346512, 5855362.027613477781415 ], [ 1388472.030306826578453, 5855370.543775821104646 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1046", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 968.29998779296875, "invlev_up": 965.79998779296875, "invlev_dn": 965.79998779296875, "manhole_up": "manhole_163_generated", "manhole_dn": "manhole_164_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388472.030306826578453, 5855370.543775821104646 ], [ 1388439.000347282737494, 5855407.802592809312046 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1047", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 964.5, "invlev_up": 965.79998779296875, "invlev_dn": 962.0, "manhole_up": "manhole_164_generated", "manhole_dn": "manhole_165_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388439.000347282737494, 5855407.802592809312046 ], [ 1388400.196091859601438, 5855436.014134516008198 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1048", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 964.5, "invlev_up": 962.0, "invlev_dn": 962.0, "manhole_up": "manhole_165_generated", "manhole_dn": "manhole_166_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388400.196091859601438, 5855436.014134516008198 ], [ 1388351.33823574683629, 5855446.634319253265858 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1049", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 981.9000244140625, "invlev_up": 962.0, "invlev_dn": 979.4000244140625, "manhole_up": "manhole_166_generated", "manhole_dn": "manhole_167_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388351.33823574683629, 5855446.634319253265858 ], [ 1388301.961881892289966, 5855453.847477887757123 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1050", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 981.9000244140625, "elevtn_dn": 981.9000244140625, "invlev_up": 979.4000244140625, "invlev_dn": 979.4000244140625, "manhole_up": "manhole_167_generated", "manhole_dn": "manhole_168_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388301.961881892289966, 5855453.847477887757123 ], [ 1388252.297577269142494, 5855451.260453455150127 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1051", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 981.9000244140625, "elevtn_dn": 973.70001220703125, "invlev_up": 979.4000244140625, "invlev_dn": 971.20001220703125, "manhole_up": "manhole_168_generated", "manhole_dn": "manhole_169_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388252.297577269142494, 5855451.260453455150127 ], [ 1388202.479659734526649, 5855455.508814659900963 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1052", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 973.70001220703125, "elevtn_dn": 961.70001220703125, "invlev_up": 971.20001220703125, "invlev_dn": 959.20001220703125, "manhole_up": "manhole_169_generated", "manhole_dn": "manhole_170_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388202.479659734526649, 5855455.508814659900963 ], [ 1388152.683455461403355, 5855460.015516467392445 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1053", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 961.70001220703125, "elevtn_dn": 961.70001220703125, "invlev_up": 959.20001220703125, "invlev_dn": 959.20001220703125, "manhole_up": "manhole_170_generated", "manhole_dn": "manhole_171_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388152.683455461403355, 5855460.015516467392445 ], [ 1388104.622611842118204, 5855473.253733876161277 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1054", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 961.70001220703125, "elevtn_dn": 945.79998779296875, "invlev_up": 959.20001220703125, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_171_generated", "manhole_dn": "manhole_172_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388104.622611842118204, 5855473.253733876161277 ], [ 1388057.00563437351957, 5855488.445189393125474 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1055", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 945.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_172_generated", "manhole_dn": "manhole_173_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388057.00563437351957, 5855488.445189393125474 ], [ 1388011.292356542311609, 5855508.700276436284184 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1056", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 945.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_173_generated", "manhole_dn": "manhole_174_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388011.292356542311609, 5855508.700276436284184 ], [ 1387969.221702651120722, 5855535.246164590120316 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1057", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 930.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 928.29998779296875, "manhole_up": "manhole_174_generated", "manhole_dn": "manhole_175_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.221702651120722, 5855535.246164590120316 ], [ 1387935.863196024205536, 5855572.491061648353934 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1058", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 930.79998779296875, "elevtn_dn": 957.10003662109375, "invlev_up": 928.29998779296875, "invlev_dn": 954.60003662109375, "manhole_up": "manhole_175_generated", "manhole_dn": "manhole_176_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387935.863196024205536, 5855572.491061648353934 ], [ 1387904.610231971368194, 5855611.432584651745856 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1059", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.10003662109375, "elevtn_dn": 947.4000244140625, "invlev_up": 954.60003662109375, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_176_generated", "manhole_dn": "manhole_177_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387904.610231971368194, 5855611.432584651745856 ], [ 1387869.335365027422085, 5855646.852918352000415 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1060", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 947.4000244140625, "invlev_up": 944.9000244140625, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_177_generated", "manhole_dn": "manhole_178_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387869.335365027422085, 5855646.852918352000415 ], [ 1387831.783288773847744, 5855679.735664095729589 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1061", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 947.4000244140625, "invlev_up": 944.9000244140625, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_178_generated", "manhole_dn": "manhole_179_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387831.783288773847744, 5855679.735664095729589 ], [ 1387791.509416193468496, 5855708.923279576934874 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1062", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 933.29998779296875, "invlev_up": 944.9000244140625, "invlev_dn": 930.79998779296875, "manhole_up": "manhole_179_generated", "manhole_dn": "manhole_180_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387791.509416193468496, 5855708.923279576934874 ], [ 1387742.459816947113723, 5855717.213657722808421 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1063", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.29998779296875, "elevtn_dn": 933.29998779296875, "invlev_up": 930.79998779296875, "invlev_dn": 930.79998779296875, "manhole_up": "manhole_180_generated", "manhole_dn": "manhole_181_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387742.459816947113723, 5855717.213657722808421 ], [ 1387692.500367184402421, 5855718.495403698645532 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1064", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.29998779296875, "elevtn_dn": 911.10003662109375, "invlev_up": 930.79998779296875, "invlev_dn": 908.60003662109375, "manhole_up": "manhole_181_generated", "manhole_dn": "manhole_182_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387692.500367184402421, 5855718.495403698645532 ], [ 1387642.500798417022452, 5855718.61967874225229 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1065", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.10003662109375, "elevtn_dn": 887.70001220703125, "invlev_up": 908.60003662109375, "invlev_dn": 885.20001220703125, "manhole_up": "manhole_182_generated", "manhole_dn": "manhole_183_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387642.500798417022452, 5855718.61967874225229 ], [ 1387592.501229649642482, 5855718.743953784927726 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1066", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 887.70001220703125, "elevtn_dn": 887.70001220703125, "invlev_up": 885.20001220703125, "invlev_dn": 885.20001220703125, "manhole_up": "manhole_183_generated", "manhole_dn": "manhole_184_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387592.501229649642482, 5855718.743953784927726 ], [ 1387542.501660882262513, 5855718.868228827603161 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1067", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 887.70001220703125, "elevtn_dn": 902.9000244140625, "invlev_up": 885.20001220703125, "invlev_dn": 900.4000244140625, "manhole_up": "manhole_184_generated", "manhole_dn": "manhole_185_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387542.501660882262513, 5855718.868228827603161 ], [ 1387492.651409652316943, 5855720.815255363471806 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1068", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 902.9000244140625, "elevtn_dn": 902.9000244140625, "invlev_up": 900.4000244140625, "invlev_dn": 900.4000244140625, "manhole_up": "manhole_185_generated", "manhole_dn": "manhole_186_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387492.651409652316943, 5855720.815255363471806 ], [ 1387448.867236748570576, 5855742.752516686916351 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1069", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 902.9000244140625, "elevtn_dn": 886.20001220703125, "invlev_up": 900.4000244140625, "invlev_dn": 883.70001220703125, "manhole_up": "manhole_186_generated", "manhole_dn": "manhole_187_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387448.867236748570576, 5855742.752516686916351 ], [ 1387402.432745414320379, 5855761.091833713464439 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1070", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 886.20001220703125, "elevtn_dn": 886.20001220703125, "invlev_up": 883.70001220703125, "invlev_dn": 883.70001220703125, "manhole_up": "manhole_187_generated", "manhole_dn": "manhole_188_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387402.432745414320379, 5855761.091833713464439 ], [ 1387355.687973388005048, 5855778.837216476909816 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1071", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 886.20001220703125, "elevtn_dn": 879.4000244140625, "invlev_up": 883.70001220703125, "invlev_dn": 876.9000244140625, "manhole_up": "manhole_188_generated", "manhole_dn": "manhole_189_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387355.687973388005048, 5855778.837216476909816 ], [ 1387308.943201361689717, 5855796.582599240355194 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1072", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 879.4000244140625, "elevtn_dn": 879.4000244140625, "invlev_up": 876.9000244140625, "invlev_dn": 876.9000244140625, "manhole_up": "manhole_189_generated", "manhole_dn": "manhole_190_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387308.943201361689717, 5855796.582599240355194 ], [ 1387262.861613623332232, 5855815.656713440082967 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1073", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 879.4000244140625, "elevtn_dn": 873.29998779296875, "invlev_up": 876.9000244140625, "invlev_dn": 870.79998779296875, "manhole_up": "manhole_190_generated", "manhole_dn": "manhole_191_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387262.861613623332232, 5855815.656713440082967 ], [ 1387224.059019178850576, 5855846.996291697025299 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1074", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 873.29998779296875, "elevtn_dn": 938.9000244140625, "invlev_up": 870.79998779296875, "invlev_dn": 936.4000244140625, "manhole_up": "manhole_191_generated", "manhole_dn": "manhole_192_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387224.059019178850576, 5855846.996291697025299 ], [ 1387180.719124856637791, 5855870.194651792757213 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1075", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 938.9000244140625, "elevtn_dn": 932.79998779296875, "invlev_up": 936.4000244140625, "invlev_dn": 930.29998779296875, "manhole_up": "manhole_192_generated", "manhole_dn": "manhole_193_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387180.719124856637791, 5855870.194651792757213 ], [ 1387131.003996425773948, 5855874.064550469629467 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1076", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.79998779296875, "elevtn_dn": 932.79998779296875, "invlev_up": 930.29998779296875, "invlev_dn": 930.29998779296875, "manhole_up": "manhole_193_generated", "manhole_dn": "manhole_194_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387131.003996425773948, 5855874.064550469629467 ], [ 1387081.098878284916282, 5855871.158613862469792 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1077", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.79998779296875, "elevtn_dn": 916.79998779296875, "invlev_up": 930.29998779296875, "invlev_dn": 914.29998779296875, "manhole_up": "manhole_194_generated", "manhole_dn": "manhole_195_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387081.098878284916282, 5855871.158613862469792 ], [ 1387031.198060098802671, 5855868.015261265449226 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1078", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 916.79998779296875, "elevtn_dn": 916.79998779296875, "invlev_up": 914.29998779296875, "invlev_dn": 914.29998779296875, "manhole_up": "manhole_195_generated", "manhole_dn": "manhole_196_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387031.198060098802671, 5855868.015261265449226 ], [ 1386981.297241912456229, 5855864.871908667497337 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1079", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 916.79998779296875, "elevtn_dn": 891.79998779296875, "invlev_up": 914.29998779296875, "invlev_dn": 889.29998779296875, "manhole_up": "manhole_196_generated", "manhole_dn": "manhole_197_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386981.297241912456229, 5855864.871908667497337 ], [ 1386931.47147326474078, 5855860.718019699677825 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1080", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.79998779296875, "elevtn_dn": 891.79998779296875, "invlev_up": 889.29998779296875, "invlev_dn": 889.29998779296875, "manhole_up": "manhole_197_generated", "manhole_dn": "manhole_198_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386931.47147326474078, 5855860.718019699677825 ], [ 1386881.600663758814335, 5855857.577047945931554 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1081", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.79998779296875, "elevtn_dn": 857.10003662109375, "invlev_up": 889.29998779296875, "invlev_dn": 854.60003662109375, "manhole_up": "manhole_198_generated", "manhole_dn": "manhole_199_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386881.600663758814335, 5855857.577047945931554 ], [ 1386832.545593914575875, 5855864.100992278195918 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1082", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 857.10003662109375, "elevtn_dn": 857.10003662109375, "invlev_up": 854.60003662109375, "invlev_dn": 854.60003662109375, "manhole_up": "manhole_199_generated", "manhole_dn": "manhole_200_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386832.545593914575875, 5855864.100992278195918 ], [ 1386787.06764860637486, 5855884.403254445642233 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1083", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 857.10003662109375, "elevtn_dn": 821.29998779296875, "invlev_up": 854.60003662109375, "invlev_dn": 818.79998779296875, "manhole_up": "manhole_200_generated", "manhole_dn": "manhole_201_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386787.06764860637486, 5855884.403254445642233 ], [ 1386748.278358669718727, 5855915.544586268253624 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1084", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 821.29998779296875, "elevtn_dn": 821.29998779296875, "invlev_up": 818.79998779296875, "invlev_dn": 818.79998779296875, "manhole_up": "manhole_201_generated", "manhole_dn": "manhole_202_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386748.278358669718727, 5855915.544586268253624 ], [ 1386721.155419877264649, 5855957.124278785660863 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1085", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 821.29998779296875, "elevtn_dn": 866.0, "invlev_up": 818.79998779296875, "invlev_dn": 863.5, "manhole_up": "manhole_202_generated", "manhole_dn": "manhole_203_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386721.155419877264649, 5855957.124278785660863 ], [ 1386707.750365849817172, 5856004.850832763127983 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1086", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 866.0, "invlev_up": 863.5, "invlev_dn": 863.5, "manhole_up": "manhole_203_generated", "manhole_dn": "manhole_204_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386707.750365849817172, 5856004.850832763127983 ], [ 1386699.832475832896307, 5856054.133603978902102 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1087", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 866.0, "invlev_up": 863.5, "invlev_dn": 863.5, "manhole_up": "manhole_204_generated", "manhole_dn": "manhole_205_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386699.832475832896307, 5856054.133603978902102 ], [ 1386697.095561265014112, 5856103.986880083568394 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1088", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 884.79998779296875, "invlev_up": 863.5, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_205_generated", "manhole_dn": "manhole_206_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386697.095561265014112, 5856103.986880083568394 ], [ 1386699.401158998254687, 5856153.933416903018951 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1089", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 884.79998779296875, "invlev_up": 882.29998779296875, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_206_generated", "manhole_dn": "manhole_207_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386699.401158998254687, 5856153.933416903018951 ], [ 1386715.699191288091242, 5856201.197657831013203 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1090", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 884.79998779296875, "invlev_up": 882.29998779296875, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_207_generated", "manhole_dn": "manhole_208_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386715.699191288091242, 5856201.197657831013203 ], [ 1386741.121203816728666, 5856244.100116757676005 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1091", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 915.9000244140625, "invlev_up": 882.29998779296875, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_208_generated", "manhole_dn": "manhole_209_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386741.121203816728666, 5856244.100116757676005 ], [ 1386774.051378605188802, 5856281.577651324681938 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1092", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_209_generated", "manhole_dn": "manhole_210_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386774.051378605188802, 5856281.577651324681938 ], [ 1386811.583791718119755, 5856314.587093180976808 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1093", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_210_generated", "manhole_dn": "manhole_211_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386811.583791718119755, 5856314.587093180976808 ], [ 1386839.378956499742344, 5856356.087350118905306 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1094", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_211_generated", "manhole_dn": "manhole_212_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386839.378956499742344, 5856356.087350118905306 ], [ 1386855.653891535941511, 5856403.364181768149137 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1095", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_212_generated", "manhole_dn": "manhole_213_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386855.653891535941511, 5856403.364181768149137 ], [ 1386875.714553950354457, 5856449.116945925168693 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1096", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_213_generated", "manhole_dn": "manhole_214_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386875.714553950354457, 5856449.116945925168693 ], [ 1386912.179653002182022, 5856482.939191372133791 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1097", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_214_generated", "manhole_dn": "manhole_215_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386912.179653002182022, 5856482.939191372133791 ], [ 1386944.191176384687424, 5856520.270725904032588 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1098", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 911.79998779296875, "invlev_up": 907.4000244140625, "invlev_dn": 909.29998779296875, "manhole_up": "manhole_215_generated", "manhole_dn": "manhole_216_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386944.191176384687424, 5856520.270725904032588 ], [ 1386964.188513180473819, 5856566.025075756013393 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1099", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.79998779296875, "elevtn_dn": 911.79998779296875, "invlev_up": 909.29998779296875, "invlev_dn": 909.29998779296875, "manhole_up": "manhole_216_generated", "manhole_dn": "manhole_217_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386964.188513180473819, 5856566.025075756013393 ], [ 1386998.825215350603685, 5856599.261941562406719 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1100", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.79998779296875, "elevtn_dn": 932.0, "invlev_up": 909.29998779296875, "invlev_dn": 929.5, "manhole_up": "manhole_217_generated", "manhole_dn": "manhole_218_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386998.825215350603685, 5856599.261941562406719 ], [ 1387044.828526843106374, 5856618.849377661012113 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1101", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 932.0, "invlev_up": 929.5, "invlev_dn": 929.5, "manhole_up": "manhole_218_generated", "manhole_dn": "manhole_219_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387044.828526843106374, 5856618.849377661012113 ], [ 1387090.831838335609064, 5856638.43681376054883 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1102", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 949.9000244140625, "invlev_up": 929.5, "invlev_dn": 947.4000244140625, "manhole_up": "manhole_219_generated", "manhole_dn": "manhole_220_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387090.831838335609064, 5856638.43681376054883 ], [ 1387136.835149827878922, 5856658.024249859154224 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1103", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 949.9000244140625, "elevtn_dn": 924.4000244140625, "invlev_up": 947.4000244140625, "invlev_dn": 921.9000244140625, "manhole_up": "manhole_220_generated", "manhole_dn": "manhole_221_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387136.835149827878922, 5856658.024249859154224 ], [ 1387178.671980312326923, 5856685.128790453076363 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1104", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 924.4000244140625, "elevtn_dn": 924.4000244140625, "invlev_up": 921.9000244140625, "invlev_dn": 921.9000244140625, "manhole_up": "manhole_221_generated", "manhole_dn": "manhole_222_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387178.671980312326923, 5856685.128790453076363 ], [ 1387217.700535611249506, 5856716.320352808572352 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1105", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 924.4000244140625, "elevtn_dn": 940.0, "invlev_up": 921.9000244140625, "invlev_dn": 937.5, "manhole_up": "manhole_222_generated", "manhole_dn": "manhole_223_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387217.700535611249506, 5856716.320352808572352 ], [ 1387252.016686553368345, 5856752.649443434551358 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1106", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.0, "elevtn_dn": 940.0, "invlev_up": 937.5, "invlev_dn": 937.5, "manhole_up": "manhole_223_generated", "manhole_dn": "manhole_224_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387252.016686553368345, 5856752.649443434551358 ], [ 1387284.798919493798167, 5856790.190159549936652 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1107", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.0, "elevtn_dn": 894.29998779296875, "invlev_up": 937.5, "invlev_dn": 891.79998779296875, "manhole_up": "manhole_224_generated", "manhole_dn": "manhole_225_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387284.798919493798167, 5856790.190159549936652 ], [ 1387273.050185391213745, 5856831.931571422144771 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1108", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 894.29998779296875, "elevtn_dn": 891.5, "invlev_up": 891.79998779296875, "invlev_dn": 889.0, "manhole_up": "manhole_225_generated", "manhole_dn": "manhole_226_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387273.050185391213745, 5856831.931571422144771 ], [ 1387226.106990416301414, 5856849.145192969590425 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1109", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.5, "elevtn_dn": 891.5, "invlev_up": 889.0, "invlev_dn": 889.0, "manhole_up": "manhole_226_generated", "manhole_dn": "manhole_227_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387226.106990416301414, 5856849.145192969590425 ], [ 1387179.163795441389084, 5856866.358814516104758 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1110", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.5, "elevtn_dn": 881.0, "invlev_up": 889.0, "invlev_dn": 878.5, "manhole_up": "manhole_227_generated", "manhole_dn": "manhole_228_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387179.163795441389084, 5856866.358814516104758 ], [ 1387132.220600466709584, 5856883.572436063550413 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1111", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_228_generated", "manhole_dn": "manhole_229_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387132.220600466709584, 5856883.572436063550413 ], [ 1387091.513159692520276, 5856911.129930667579174 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1112", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_229_generated", "manhole_dn": "manhole_230_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387091.513159692520276, 5856911.129930667579174 ], [ 1387071.007118243258446, 5856956.15559543017298 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1113", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_230_generated", "manhole_dn": "manhole_231_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387071.007118243258446, 5856956.15559543017298 ], [ 1387043.749112035380676, 5856996.689189162105322 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1114", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 856.5, "invlev_up": 878.5, "invlev_dn": 854.0, "manhole_up": "manhole_231_generated", "manhole_dn": "manhole_232_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387043.749112035380676, 5856996.689189162105322 ], [ 1387004.639443967491388, 5857027.840532388538122 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1115", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_232_generated", "manhole_dn": "manhole_233_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387004.639443967491388, 5857027.840532388538122 ], [ 1386965.529775899834931, 5857058.991875615902245 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1116", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_233_generated", "manhole_dn": "manhole_234_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386965.529775899834931, 5857058.991875615902245 ], [ 1386926.702535050921142, 5857090.440239730291069 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1117", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_234_generated", "manhole_dn": "manhole_235_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386926.702535050921142, 5857090.440239730291069 ], [ 1386899.700979894958436, 5857131.871505072340369 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1118", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_235_generated", "manhole_dn": "manhole_236_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386899.700979894958436, 5857131.871505072340369 ], [ 1386903.6263940166682, 5857181.005935152061284 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1119", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 867.29998779296875, "invlev_up": 854.0, "invlev_dn": 864.79998779296875, "manhole_up": "manhole_236_generated", "manhole_dn": "manhole_237_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386903.6263940166682, 5857181.005935152061284 ], [ 1386920.841401966754347, 5857227.85734468139708 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1120", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 867.29998779296875, "elevtn_dn": 867.29998779296875, "invlev_up": 864.79998779296875, "invlev_dn": 864.79998779296875, "manhole_up": "manhole_237_generated", "manhole_dn": "manhole_238_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386920.841401966754347, 5857227.85734468139708 ], [ 1386940.647245415020734, 5857273.767048302106559 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1121", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 867.29998779296875, "elevtn_dn": 879.0, "invlev_up": 864.79998779296875, "invlev_dn": 876.5, "manhole_up": "manhole_238_generated", "manhole_dn": "manhole_239_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386940.647245415020734, 5857273.767048302106559 ], [ 1386960.453088863519952, 5857319.676751921884716 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1122", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 879.0, "elevtn_dn": 884.5, "invlev_up": 876.5, "invlev_dn": 882.0, "manhole_up": "manhole_239_generated", "manhole_dn": "manhole_240_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386960.453088863519952, 5857319.676751921884716 ], [ 1386980.258932311786339, 5857365.586455542594194 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1123", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 884.5, "invlev_up": 882.0, "invlev_dn": 882.0, "manhole_up": "manhole_240_generated", "manhole_dn": "manhole_241_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386980.258932311786339, 5857365.586455542594194 ], [ 1387000.064775760285556, 5857411.496159162372351 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1124", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 884.5, "invlev_up": 882.0, "invlev_dn": 882.0, "manhole_up": "manhole_241_generated", "manhole_dn": "manhole_242_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387000.064775760285556, 5857411.496159162372351 ], [ 1387007.528902114601806, 5857459.537025099620223 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1125", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 893.20001220703125, "invlev_up": 882.0, "invlev_dn": 890.70001220703125, "manhole_up": "manhole_242_generated", "manhole_dn": "manhole_243_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387007.528902114601806, 5857459.537025099620223 ], [ 1386963.21676475298591, 5857476.629049208015203 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1126", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 893.20001220703125, "elevtn_dn": 893.70001220703125, "invlev_up": 890.70001220703125, "invlev_dn": 891.20001220703125, "manhole_up": "manhole_243_generated", "manhole_dn": "manhole_244_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386963.21676475298591, 5857476.629049208015203 ], [ 1386913.783934087026864, 5857484.135433598421514 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1127", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 893.70001220703125, "elevtn_dn": 893.70001220703125, "invlev_up": 891.20001220703125, "invlev_dn": 891.20001220703125, "manhole_up": "manhole_244_generated", "manhole_dn": "manhole_245_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386913.783934087026864, 5857484.135433598421514 ], [ 1386870.539328352315351, 5857507.055611960589886 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1128", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 893.70001220703125, "elevtn_dn": 889.70001220703125, "invlev_up": 891.20001220703125, "invlev_dn": 887.20001220703125, "manhole_up": "manhole_245_generated", "manhole_dn": "manhole_246_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386870.539328352315351, 5857507.055611960589886 ], [ 1386832.820274166297168, 5857539.877026806585491 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1129", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.70001220703125, "elevtn_dn": 889.70001220703125, "invlev_up": 887.20001220703125, "invlev_dn": 887.20001220703125, "manhole_up": "manhole_246_generated", "manhole_dn": "manhole_247_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386832.820274166297168, 5857539.877026806585491 ], [ 1386795.101531907683238, 5857572.698800123296678 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1130", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.70001220703125, "elevtn_dn": 872.4000244140625, "invlev_up": 887.20001220703125, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_247_generated", "manhole_dn": "manhole_248_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386795.101531907683238, 5857572.698800123296678 ], [ 1386758.257366374600679, 5857606.496797049418092 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1131", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 872.4000244140625, "invlev_up": 869.9000244140625, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_248_generated", "manhole_dn": "manhole_249_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386758.257366374600679, 5857606.496797049418092 ], [ 1386721.502390186069533, 5857640.394349270500243 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1132", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 872.4000244140625, "invlev_up": 869.9000244140625, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_249_generated", "manhole_dn": "manhole_250_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386721.502390186069533, 5857640.394349270500243 ], [ 1386691.639095245627686, 5857680.292891399934888 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1133", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 860.70001220703125, "invlev_up": 869.9000244140625, "invlev_dn": 858.20001220703125, "manhole_up": "manhole_250_generated", "manhole_dn": "manhole_251_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386691.639095245627686, 5857680.292891399934888 ], [ 1386663.127201205352321, 5857721.366519738920033 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1134", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 860.70001220703125, "elevtn_dn": 864.10003662109375, "invlev_up": 858.20001220703125, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_251_generated", "manhole_dn": "manhole_252_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386663.127201205352321, 5857721.366519738920033 ], [ 1386634.70784462057054, 5857762.504245642572641 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1135", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 864.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_252_generated", "manhole_dn": "manhole_253_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386634.70784462057054, 5857762.504245642572641 ], [ 1386606.28848803602159, 5857803.64197154622525 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1136", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 864.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_253_generated", "manhole_dn": "manhole_254_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386606.28848803602159, 5857803.64197154622525 ], [ 1386577.851668093586341, 5857844.766917760483921 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1137", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 836.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 833.60003662109375, "manhole_up": "manhole_254_generated", "manhole_dn": "manhole_255_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386577.851668093586341, 5857844.766917760483921 ], [ 1386559.479123871540651, 5857890.340473555959761 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1138", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 836.10003662109375, "elevtn_dn": 836.10003662109375, "invlev_up": 833.60003662109375, "invlev_dn": 833.60003662109375, "manhole_up": "manhole_255_generated", "manhole_dn": "manhole_256_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386559.479123871540651, 5857890.340473555959761 ], [ 1386576.858566463226452, 5857935.633445805869997 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1139", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 836.10003662109375, "elevtn_dn": 854.9000244140625, "invlev_up": 833.60003662109375, "invlev_dn": 852.4000244140625, "manhole_up": "manhole_256_generated", "manhole_dn": "manhole_257_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386576.858566463226452, 5857935.633445805869997 ], [ 1386619.073707325849682, 5857961.189545376226306 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1140", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.9000244140625, "elevtn_dn": 854.9000244140625, "invlev_up": 852.4000244140625, "invlev_dn": 852.4000244140625, "manhole_up": "manhole_257_generated", "manhole_dn": "manhole_258_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386619.073707325849682, 5857961.189545376226306 ], [ 1386664.860782509436831, 5857981.27706332411617 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1141", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.9000244140625, "elevtn_dn": 871.60003662109375, "invlev_up": 852.4000244140625, "invlev_dn": 869.10003662109375, "manhole_up": "manhole_258_generated", "manhole_dn": "manhole_259_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386664.860782509436831, 5857981.27706332411617 ], [ 1386710.721602912992239, 5858001.195835201069713 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1142", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 871.60003662109375, "elevtn_dn": 865.10003662109375, "invlev_up": 869.10003662109375, "invlev_dn": 862.60003662109375, "manhole_up": "manhole_259_generated", "manhole_dn": "manhole_260_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386710.721602912992239, 5858001.195835201069713 ], [ 1386756.582423316547647, 5858021.114607078954577 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1143", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 865.10003662109375, "elevtn_dn": 864.70001220703125, "invlev_up": 862.60003662109375, "invlev_dn": 862.20001220703125, "manhole_up": "manhole_260_generated", "manhole_dn": "manhole_261_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386756.582423316547647, 5858021.114607078954577 ], [ 1386802.443243720103055, 5858041.033378956839442 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1144", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.70001220703125, "elevtn_dn": 864.70001220703125, "invlev_up": 862.20001220703125, "invlev_dn": 862.20001220703125, "manhole_up": "manhole_261_generated", "manhole_dn": "manhole_262_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386802.443243720103055, 5858041.033378956839442 ], [ 1386848.304064123658463, 5858060.952150834724307 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1145", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.70001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 862.20001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_262_generated", "manhole_dn": "manhole_263_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386848.304064123658463, 5858060.952150834724307 ], [ 1386892.843548113014549, 5858083.471454747952521 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1146", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_263_generated", "manhole_dn": "manhole_264_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386892.843548113014549, 5858083.471454747952521 ], [ 1386931.443847785238177, 5858115.251781782135367 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1147", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 853.60003662109375, "invlev_up": 856.70001220703125, "invlev_dn": 851.10003662109375, "manhole_up": "manhole_264_generated", "manhole_dn": "manhole_265_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386931.443847785238177, 5858115.251781782135367 ], [ 1386970.044147457228974, 5858147.032108817249537 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1148", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 853.60003662109375, "elevtn_dn": 853.60003662109375, "invlev_up": 851.10003662109375, "invlev_dn": 851.10003662109375, "manhole_up": "manhole_265_generated", "manhole_dn": "manhole_266_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386970.044147457228974, 5858147.032108817249537 ], [ 1387008.644447129452601, 5858178.812435851432383 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1149", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 853.60003662109375, "elevtn_dn": 842.4000244140625, "invlev_up": 851.10003662109375, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_266_generated", "manhole_dn": "manhole_267_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387008.644447129452601, 5858178.812435851432383 ], [ 1387047.244746801443398, 5858210.592762886546552 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1150", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 842.4000244140625, "invlev_up": 839.9000244140625, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_267_generated", "manhole_dn": "manhole_268_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387047.244746801443398, 5858210.592762886546552 ], [ 1387085.845046473667026, 5858242.373089920729399 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1151", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 842.4000244140625, "invlev_up": 839.9000244140625, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_268_generated", "manhole_dn": "manhole_269_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387085.845046473667026, 5858242.373089920729399 ], [ 1387124.445346145657822, 5858274.153416955843568 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1152", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 827.60003662109375, "invlev_up": 839.9000244140625, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_269_generated", "manhole_dn": "manhole_270_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387124.445346145657822, 5858274.153416955843568 ], [ 1387163.04564581788145, 5858305.933743990026414 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1153", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_270_generated", "manhole_dn": "manhole_271_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387163.04564581788145, 5858305.933743990026414 ], [ 1387201.829349192325026, 5858337.489215047098696 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1154", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 837.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 835.10003662109375, "manhole_up": "manhole_271_generated", "manhole_dn": "manhole_272_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387201.829349192325026, 5858337.489215047098696 ], [ 1387246.200623227981851, 5858359.687651782296598 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1155", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 837.60003662109375, "elevtn_dn": 837.60003662109375, "invlev_up": 835.10003662109375, "invlev_dn": 835.10003662109375, "manhole_up": "manhole_272_generated", "manhole_dn": "manhole_273_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387246.200623227981851, 5858359.687651782296598 ], [ 1387293.201938283629715, 5858376.741938757710159 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1156", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 837.60003662109375, "elevtn_dn": 843.79998779296875, "invlev_up": 835.10003662109375, "invlev_dn": 841.29998779296875, "manhole_up": "manhole_273_generated", "manhole_dn": "manhole_274_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387293.201938283629715, 5858376.741938757710159 ], [ 1387334.200528149493039, 5858401.732468435540795 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1157", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 843.79998779296875, "elevtn_dn": 822.60003662109375, "invlev_up": 841.29998779296875, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_274_generated", "manhole_dn": "manhole_275_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387334.200528149493039, 5858401.732468435540795 ], [ 1387307.843875054037198, 5858437.110805934295058 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1158", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 822.60003662109375, "invlev_up": 820.10003662109375, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_275_generated", "manhole_dn": "manhole_276_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387307.843875054037198, 5858437.110805934295058 ], [ 1387260.279569417703897, 5858425.045736069791019 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1159", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 820.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_276_generated", "manhole_dn": "manhole_277_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387260.279569417703897, 5858425.045736069791019 ], [ 1387211.448235018178821, 5858414.300554806366563 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1160", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_277_generated", "manhole_dn": "manhole_278_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387211.448235018178821, 5858414.300554806366563 ], [ 1387162.612191663123667, 5858403.576134512200952 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1161", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 822.29998779296875, "invlev_up": 825.10003662109375, "invlev_dn": 819.79998779296875, "manhole_up": "manhole_278_generated", "manhole_dn": "manhole_279_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387162.612191663123667, 5858403.576134512200952 ], [ 1387113.700150535441935, 5858393.210482948459685 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1162", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.29998779296875, "elevtn_dn": 822.29998779296875, "invlev_up": 819.79998779296875, "invlev_dn": 819.79998779296875, "manhole_up": "manhole_279_generated", "manhole_dn": "manhole_280_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387113.700150535441935, 5858393.210482948459685 ], [ 1387064.993171223672107, 5858381.975642333738506 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1163", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.29998779296875, "elevtn_dn": 827.79998779296875, "invlev_up": 819.79998779296875, "invlev_dn": 825.29998779296875, "manhole_up": "manhole_280_generated", "manhole_dn": "manhole_281_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387064.993171223672107, 5858381.975642333738506 ], [ 1387015.796386598376557, 5858376.342007979750633 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1164", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.79998779296875, "elevtn_dn": 827.79998779296875, "invlev_up": 825.29998779296875, "invlev_dn": 825.29998779296875, "manhole_up": "manhole_281_generated", "manhole_dn": "manhole_282_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387015.796386598376557, 5858376.342007979750633 ], [ 1386966.208506174152717, 5858382.746259398758411 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1165", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.79998779296875, "elevtn_dn": 833.9000244140625, "invlev_up": 825.29998779296875, "invlev_dn": 831.4000244140625, "manhole_up": "manhole_282_generated", "manhole_dn": "manhole_283_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386966.208506174152717, 5858382.746259398758411 ], [ 1386916.676812386140227, 5858389.559525708667934 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1166", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 833.9000244140625, "elevtn_dn": 833.9000244140625, "invlev_up": 831.4000244140625, "invlev_dn": 831.4000244140625, "manhole_up": "manhole_283_generated", "manhole_dn": "manhole_284_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386916.676812386140227, 5858389.559525708667934 ], [ 1386867.198860567295924, 5858396.764010772109032 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1167", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 833.9000244140625, "elevtn_dn": 833.20001220703125, "invlev_up": 831.4000244140625, "invlev_dn": 830.70001220703125, "manhole_up": "manhole_284_generated", "manhole_dn": "manhole_285_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386867.198860567295924, 5858396.764010772109032 ], [ 1386820.816385147860274, 5858411.854353901930153 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1168", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 833.20001220703125, "elevtn_dn": 809.60003662109375, "invlev_up": 830.70001220703125, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_285_generated", "manhole_dn": "manhole_286_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386820.816385147860274, 5858411.854353901930153 ], [ 1386841.361234750133008, 5858445.514383808709681 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1169", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 809.79998779296875, "invlev_up": 807.10003662109375, "invlev_dn": 807.29998779296875, "manhole_up": "manhole_286_generated", "manhole_dn": "manhole_287_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386841.361234750133008, 5858445.514383808709681 ], [ 1386890.796275103231892, 5858452.915634987875819 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1170", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.79998779296875, "elevtn_dn": 809.79998779296875, "invlev_up": 807.29998779296875, "invlev_dn": 807.29998779296875, "manhole_up": "manhole_287_generated", "manhole_dn": "manhole_288_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386890.796275103231892, 5858452.915634987875819 ], [ 1386940.277140651131049, 5858460.100081093609333 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1171", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.79998779296875, "elevtn_dn": 805.4000244140625, "invlev_up": 807.29998779296875, "invlev_dn": 802.9000244140625, "manhole_up": "manhole_288_generated", "manhole_dn": "manhole_289_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386940.277140651131049, 5858460.100081093609333 ], [ 1386989.847997799050063, 5858466.483407464809716 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1172", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.4000244140625, "elevtn_dn": 805.4000244140625, "invlev_up": 802.9000244140625, "invlev_dn": 802.9000244140625, "manhole_up": "manhole_289_generated", "manhole_dn": "manhole_290_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386989.847997799050063, 5858466.483407464809716 ], [ 1387039.689648573985323, 5858470.45608530472964 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1173", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.4000244140625, "elevtn_dn": 804.60003662109375, "invlev_up": 802.9000244140625, "invlev_dn": 802.10003662109375, "manhole_up": "manhole_290_generated", "manhole_dn": "manhole_291_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387039.689648573985323, 5858470.45608530472964 ], [ 1387088.843806148739532, 5858479.424946941435337 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1174", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.60003662109375, "elevtn_dn": 809.9000244140625, "invlev_up": 802.10003662109375, "invlev_dn": 807.4000244140625, "manhole_up": "manhole_291_generated", "manhole_dn": "manhole_292_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387088.843806148739532, 5858479.424946941435337 ], [ 1387137.90604472765699, 5858489.061806742101908 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1175", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.9000244140625, "elevtn_dn": 809.9000244140625, "invlev_up": 807.4000244140625, "invlev_dn": 807.4000244140625, "manhole_up": "manhole_292_generated", "manhole_dn": "manhole_293_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387137.90604472765699, 5858489.061806742101908 ], [ 1387186.336529975291342, 5858500.87968063633889 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1176", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.9000244140625, "elevtn_dn": 822.60003662109375, "invlev_up": 807.4000244140625, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_293_generated", "manhole_dn": "manhole_294_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387186.336529975291342, 5858500.87968063633889 ], [ 1387231.661050535272807, 5858521.423059928230941 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1177", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 787.70001220703125, "invlev_up": 820.10003662109375, "invlev_dn": 785.20001220703125, "manhole_up": "manhole_294_generated", "manhole_dn": "manhole_295_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387231.661050535272807, 5858521.423059928230941 ], [ 1387268.120024613803253, 5858555.03504909388721 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1178", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.70001220703125, "elevtn_dn": 787.70001220703125, "invlev_up": 785.20001220703125, "invlev_dn": 785.20001220703125, "manhole_up": "manhole_295_generated", "manhole_dn": "manhole_296_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387268.120024613803253, 5858555.03504909388721 ], [ 1387300.917169471969828, 5858592.775208213366568 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1179", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.70001220703125, "elevtn_dn": 797.10003662109375, "invlev_up": 785.20001220703125, "invlev_dn": 794.60003662109375, "manhole_up": "manhole_296_generated", "manhole_dn": "manhole_297_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387300.917169471969828, 5858592.775208213366568 ], [ 1387340.521646688459441, 5858622.315198052674532 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1180", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 797.10003662109375, "elevtn_dn": 797.10003662109375, "invlev_up": 794.60003662109375, "invlev_dn": 794.60003662109375, "manhole_up": "manhole_297_generated", "manhole_dn": "manhole_298_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387340.521646688459441, 5858622.315198052674532 ], [ 1387387.476920192595571, 5858639.495844470337033 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1181", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 797.10003662109375, "elevtn_dn": 806.10003662109375, "invlev_up": 794.60003662109375, "invlev_dn": 803.60003662109375, "manhole_up": "manhole_298_generated", "manhole_dn": "manhole_299_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387387.476920192595571, 5858639.495844470337033 ], [ 1387436.116963447071612, 5858650.82861250359565 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1182", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.10003662109375, "elevtn_dn": 806.10003662109375, "invlev_up": 803.60003662109375, "invlev_dn": 803.60003662109375, "manhole_up": "manhole_299_generated", "manhole_dn": "manhole_300_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387436.116963447071612, 5858650.82861250359565 ], [ 1387485.194103535497561, 5858660.261457678861916 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1183", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.10003662109375, "elevtn_dn": 807.70001220703125, "invlev_up": 803.60003662109375, "invlev_dn": 805.20001220703125, "manhole_up": "manhole_300_generated", "manhole_dn": "manhole_301_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387485.194103535497561, 5858660.261457678861916 ], [ 1387533.804190448950976, 5858671.493853995576501 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1184", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.70001220703125, "elevtn_dn": 772.20001220703125, "invlev_up": 805.20001220703125, "invlev_dn": 769.70001220703125, "manhole_up": "manhole_301_generated", "manhole_dn": "manhole_302_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387533.804190448950976, 5858671.493853995576501 ], [ 1387580.2968336828053, 5858689.619015210308135 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1185", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.20001220703125, "elevtn_dn": 778.79998779296875, "invlev_up": 769.70001220703125, "invlev_dn": 776.29998779296875, "manhole_up": "manhole_302_generated", "manhole_dn": "manhole_303_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387580.2968336828053, 5858689.619015210308135 ], [ 1387628.455277157016098, 5858703.062848121859133 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1186", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.79998779296875, "elevtn_dn": 778.79998779296875, "invlev_up": 776.29998779296875, "invlev_dn": 776.29998779296875, "manhole_up": "manhole_303_generated", "manhole_dn": "manhole_304_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387628.455277157016098, 5858703.062848121859133 ], [ 1387677.211432087467983, 5858713.7862489502877 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1187", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.79998779296875, "elevtn_dn": 786.70001220703125, "invlev_up": 776.29998779296875, "invlev_dn": 784.20001220703125, "manhole_up": "manhole_304_generated", "manhole_dn": "manhole_305_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387677.211432087467983, 5858713.7862489502877 ], [ 1387726.995392211945727, 5858712.747126803733408 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1188", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.70001220703125, "elevtn_dn": 786.70001220703125, "invlev_up": 784.20001220703125, "invlev_dn": 784.20001220703125, "manhole_up": "manhole_305_generated", "manhole_dn": "manhole_306_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387726.995392211945727, 5858712.747126803733408 ], [ 1387773.343349169706926, 5858725.014477553777397 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1189", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.70001220703125, "elevtn_dn": 797.70001220703125, "invlev_up": 784.20001220703125, "invlev_dn": 795.20001220703125, "manhole_up": "manhole_306_generated", "manhole_dn": "manhole_307_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387773.343349169706926, 5858725.014477553777397 ], [ 1387806.363672176143155, 5858762.310494473204017 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1190", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 797.70001220703125, "elevtn_dn": 797.70001220703125, "invlev_up": 795.20001220703125, "invlev_dn": 795.20001220703125, "manhole_up": "manhole_307_generated", "manhole_dn": "manhole_308_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387806.363672176143155, 5858762.310494473204017 ], [ 1387799.717027904232964, 5858810.149600365199149 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1191", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 797.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 795.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_308_generated", "manhole_dn": "manhole_309_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387799.717027904232964, 5858810.149600365199149 ], [ 1387771.971139753237367, 5858850.86109375115484 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1192", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_309_generated", "manhole_dn": "manhole_310_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387771.971139753237367, 5858850.86109375115484 ], [ 1387723.07675126590766, 5858854.679317841306329 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1193", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_310_generated", "manhole_dn": "manhole_311_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387723.07675126590766, 5858854.679317841306329 ], [ 1387673.274138238513842, 5858850.996178055182099 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1194", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_311_generated", "manhole_dn": "manhole_312_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387673.274138238513842, 5858850.996178055182099 ], [ 1387624.170362570788711, 5858858.384703231044114 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1195", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_312_generated", "manhole_dn": "manhole_313_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387624.170362570788711, 5858858.384703231044114 ], [ 1387575.715393897145987, 5858857.046076283790171 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1196", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_313_generated", "manhole_dn": "manhole_314_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387575.715393897145987, 5858857.046076283790171 ], [ 1387529.438332577701658, 5858838.116818149574101 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1197", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_314_generated", "manhole_dn": "manhole_315_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387529.438332577701658, 5858838.116818149574101 ], [ 1387481.179235466290265, 5858825.222027675248682 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1198", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_315_generated", "manhole_dn": "manhole_316_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387481.179235466290265, 5858825.222027675248682 ], [ 1387432.215501294471323, 5858815.797906777821481 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1199", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 772.79998779296875, "invlev_up": 774.70001220703125, "invlev_dn": 770.29998779296875, "manhole_up": "manhole_316_generated", "manhole_dn": "manhole_317_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387432.215501294471323, 5858815.797906777821481 ], [ 1387382.431881646160036, 5858811.154251328669488 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1200", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.79998779296875, "elevtn_dn": 747.10003662109375, "invlev_up": 770.29998779296875, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_317_generated", "manhole_dn": "manhole_318_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387382.431881646160036, 5858811.154251328669488 ], [ 1387336.607072548242286, 5858824.075685098767281 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1201", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 747.10003662109375, "invlev_up": 744.60003662109375, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_318_generated", "manhole_dn": "manhole_319_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387336.607072548242286, 5858824.075685098767281 ], [ 1387327.458137275883928, 5858870.88596049696207 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1202", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 747.10003662109375, "invlev_up": 744.60003662109375, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_319_generated", "manhole_dn": "manhole_320_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387327.458137275883928, 5858870.88596049696207 ], [ 1387344.619252334116027, 5858917.848375800997019 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1203", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 773.70001220703125, "invlev_up": 744.60003662109375, "invlev_dn": 771.20001220703125, "manhole_up": "manhole_320_generated", "manhole_dn": "manhole_321_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387344.619252334116027, 5858917.848375800997019 ], [ 1387358.089983508689329, 5858965.710649829357862 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1204", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 773.70001220703125, "elevtn_dn": 773.70001220703125, "invlev_up": 771.20001220703125, "invlev_dn": 771.20001220703125, "manhole_up": "manhole_321_generated", "manhole_dn": "manhole_322_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387358.089983508689329, 5858965.710649829357862 ], [ 1387329.564612702699378, 5859003.583583393134177 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1205", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 773.70001220703125, "elevtn_dn": 774.29998779296875, "invlev_up": 771.20001220703125, "invlev_dn": 771.79998779296875, "manhole_up": "manhole_322_generated", "manhole_dn": "manhole_323_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387329.564612702699378, 5859003.583583393134177 ], [ 1387285.783744251355529, 5858993.703191691078246 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1206", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.29998779296875, "elevtn_dn": 774.29998779296875, "invlev_up": 771.79998779296875, "invlev_dn": 771.79998779296875, "manhole_up": "manhole_323_generated", "manhole_dn": "manhole_324_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387285.783744251355529, 5858993.703191691078246 ], [ 1387248.355973182013258, 5858961.31797497626394 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1207", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.29998779296875, "elevtn_dn": 769.4000244140625, "invlev_up": 771.79998779296875, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_324_generated", "manhole_dn": "manhole_325_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387248.355973182013258, 5858961.31797497626394 ], [ 1387199.500433639157563, 5858963.645901591517031 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1208", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 769.4000244140625, "invlev_up": 766.9000244140625, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_325_generated", "manhole_dn": "manhole_326_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387199.500433639157563, 5858963.645901591517031 ], [ 1387151.482699199579656, 5858977.583961015567183 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1209", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 762.60003662109375, "invlev_up": 766.9000244140625, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_326_generated", "manhole_dn": "manhole_327_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387151.482699199579656, 5858977.583961015567183 ], [ 1387103.632611613254994, 5858992.082134889438748 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1210", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 762.60003662109375, "invlev_up": 760.10003662109375, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_327_generated", "manhole_dn": "manhole_328_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387103.632611613254994, 5858992.082134889438748 ], [ 1387055.853339510038495, 5859006.816905959509313 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1211", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 755.79998779296875, "invlev_up": 760.10003662109375, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_328_generated", "manhole_dn": "manhole_329_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387055.853339510038495, 5859006.816905959509313 ], [ 1387008.074067406589165, 5859021.551677029579878 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1212", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_329_generated", "manhole_dn": "manhole_330_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387008.074067406589165, 5859021.551677029579878 ], [ 1386960.294795303372666, 5859036.286448099650443 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1213", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 749.5, "invlev_up": 753.29998779296875, "invlev_dn": 747.0, "manhole_up": "manhole_330_generated", "manhole_dn": "manhole_331_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386960.294795303372666, 5859036.286448099650443 ], [ 1386912.515523200156167, 5859051.021219169721007 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1214", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 749.5, "elevtn_dn": 749.5, "invlev_up": 747.0, "invlev_dn": 747.0, "manhole_up": "manhole_331_generated", "manhole_dn": "manhole_332_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386912.515523200156167, 5859051.021219169721007 ], [ 1386864.736251096706837, 5859065.755990239791572 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1215", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 749.5, "elevtn_dn": 727.10003662109375, "invlev_up": 747.0, "invlev_dn": 724.60003662109375, "manhole_up": "manhole_332_generated", "manhole_dn": "manhole_333_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386864.736251096706837, 5859065.755990239791572 ], [ 1386816.956978993490338, 5859080.490761309862137 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1216", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.10003662109375, "elevtn_dn": 752.29998779296875, "invlev_up": 724.60003662109375, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_333_generated", "manhole_dn": "manhole_334_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386816.956978993490338, 5859080.490761309862137 ], [ 1386769.832018451532349, 5859096.976014334708452 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1217", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 738.0, "invlev_up": 749.79998779296875, "invlev_dn": 735.5, "manhole_up": "manhole_334_generated", "manhole_dn": "manhole_335_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386769.832018451532349, 5859096.976014334708452 ], [ 1386724.102282747160643, 5859117.193917133845389 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1218", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 738.0, "invlev_up": 735.5, "invlev_dn": 735.5, "manhole_up": "manhole_335_generated", "manhole_dn": "manhole_336_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386724.102282747160643, 5859117.193917133845389 ], [ 1386678.372547042788938, 5859137.411819933913648 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1219", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 732.79998779296875, "invlev_up": 735.5, "invlev_dn": 730.29998779296875, "manhole_up": "manhole_336_generated", "manhole_dn": "manhole_337_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386678.372547042788938, 5859137.411819933913648 ], [ 1386632.642811338417232, 5859157.629722733050585 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1220", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.79998779296875, "elevtn_dn": 732.79998779296875, "invlev_up": 730.29998779296875, "invlev_dn": 730.29998779296875, "manhole_up": "manhole_337_generated", "manhole_dn": "manhole_338_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386632.642811338417232, 5859157.629722733050585 ], [ 1386586.913075634045526, 5859177.847625533118844 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1221", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.79998779296875, "elevtn_dn": 732.60003662109375, "invlev_up": 730.29998779296875, "invlev_dn": 730.10003662109375, "manhole_up": "manhole_338_generated", "manhole_dn": "manhole_339_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386586.913075634045526, 5859177.847625533118844 ], [ 1386541.181931287748739, 5859198.062337793409824 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1222", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.60003662109375, "elevtn_dn": 732.60003662109375, "invlev_up": 730.10003662109375, "invlev_dn": 730.10003662109375, "manhole_up": "manhole_339_generated", "manhole_dn": "manhole_340_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386541.181931287748739, 5859198.062337793409824 ], [ 1386495.431538854492828, 5859218.233453613705933 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1223", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.60003662109375, "elevtn_dn": 742.5, "invlev_up": 730.10003662109375, "invlev_dn": 740.0, "manhole_up": "manhole_340_generated", "manhole_dn": "manhole_341_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386495.431538854492828, 5859218.233453613705933 ], [ 1386449.681146421469748, 5859238.404569433070719 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1224", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 742.5, "invlev_up": 740.0, "invlev_dn": 740.0, "manhole_up": "manhole_341_generated", "manhole_dn": "manhole_342_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386449.681146421469748, 5859238.404569433070719 ], [ 1386404.749107032548636, 5859260.314221715554595 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1225", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 717.60003662109375, "invlev_up": 740.0, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_342_generated", "manhole_dn": "manhole_343_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386404.749107032548636, 5859260.314221715554595 ], [ 1386360.756595908896998, 5859284.020064728334546 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1226", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 717.60003662109375, "invlev_up": 715.10003662109375, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_343_generated", "manhole_dn": "manhole_344_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386360.756595908896998, 5859284.020064728334546 ], [ 1386317.622744857333601, 5859309.307279178872705 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1227", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 711.0, "invlev_up": 715.10003662109375, "invlev_dn": 708.5, "manhole_up": "manhole_344_generated", "manhole_dn": "manhole_345_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386317.622744857333601, 5859309.307279178872705 ], [ 1386274.488893805770203, 5859334.594493629410863 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1228", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 711.0, "elevtn_dn": 717.60003662109375, "invlev_up": 708.5, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_345_generated", "manhole_dn": "manhole_346_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386274.488893805770203, 5859334.594493629410863 ], [ 1386231.354723542230204, 5859359.881163572892547 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1229", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 739.0, "invlev_up": 715.10003662109375, "invlev_dn": 736.5, "manhole_up": "manhole_346_generated", "manhole_dn": "manhole_347_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386231.354723542230204, 5859359.881163572892547 ], [ 1386188.788941488368437, 5859385.978958465158939 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1230", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 739.0, "invlev_up": 736.5, "invlev_dn": 736.5, "manhole_up": "manhole_347_generated", "manhole_dn": "manhole_348_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386188.788941488368437, 5859385.978958465158939 ], [ 1386153.170269979629666, 5859420.751348914578557 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1231", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 739.0, "invlev_up": 736.5, "invlev_dn": 736.5, "manhole_up": "manhole_348_generated", "manhole_dn": "manhole_349_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386153.170269979629666, 5859420.751348914578557 ], [ 1386127.241226618411019, 5859463.08446778729558 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1232", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 770.60003662109375, "invlev_up": 736.5, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_349_generated", "manhole_dn": "manhole_350_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386127.241226618411019, 5859463.08446778729558 ], [ 1386108.996456971857697, 5859509.052053713239729 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1233", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_350_generated", "manhole_dn": "manhole_351_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386108.996456971857697, 5859509.052053713239729 ], [ 1386105.954033384332433, 5859558.959127158857882 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1234", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_351_generated", "manhole_dn": "manhole_352_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386105.954033384332433, 5859558.959127158857882 ], [ 1386101.917093347059563, 5859608.782215913757682 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1235", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 779.79998779296875, "invlev_up": 768.10003662109375, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_352_generated", "manhole_dn": "manhole_353_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386101.917093347059563, 5859608.782215913757682 ], [ 1386088.458339030388743, 5859656.652665913105011 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1236", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 779.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_353_generated", "manhole_dn": "manhole_354_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386088.458339030388743, 5859656.652665913105011 ], [ 1386075.652030121767893, 5859704.419184413738549 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1237", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 779.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_354_generated", "manhole_dn": "manhole_355_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386075.652030121767893, 5859704.419184413738549 ], [ 1386076.574770522769541, 5859754.410392354242504 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1238", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_355_generated", "manhole_dn": "manhole_356_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386076.574770522769541, 5859754.410392354242504 ], [ 1386077.497510923538357, 5859804.401600294746459 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_9_E1239", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_356_generated", "manhole_dn": "manhole_357_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386077.497510923538357, 5859804.401600294746459 ], [ 1386078.420251324307173, 5859854.392808235250413 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E195", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 814.29998779296875, "elevtn_dn": 802.9000244140625, "invlev_up": 811.79998779296875, "invlev_dn": 800.4000244140625, "manhole_up": "manhole_358_generated", "manhole_dn": "manhole_359_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384050.267680946970358, 5856698.702001548372209 ], [ 1384085.778961833100766, 5856733.441067186184227 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E196", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.9000244140625, "elevtn_dn": 802.9000244140625, "invlev_up": 800.4000244140625, "invlev_dn": 800.4000244140625, "manhole_up": "manhole_359_generated", "manhole_dn": "manhole_360_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384085.778961833100766, 5856733.441067186184227 ], [ 1384122.993944165529683, 5856766.592179889790714 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E197", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.9000244140625, "elevtn_dn": 816.29998779296875, "invlev_up": 800.4000244140625, "invlev_dn": 813.79998779296875, "manhole_up": "manhole_360_generated", "manhole_dn": "manhole_361_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384122.993944165529683, 5856766.592179889790714 ], [ 1384160.350959801580757, 5856799.578122235834599 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E198", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.29998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 813.79998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_361_generated", "manhole_dn": "manhole_362_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384160.350959801580757, 5856799.578122235834599 ], [ 1384198.384374253917485, 5856831.724873264320195 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E199", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 798.29998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_362_generated", "manhole_dn": "manhole_363_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384198.384374253917485, 5856831.724873264320195 ], [ 1384230.112839305773377, 5856870.159957353956997 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E200", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 793.9000244140625, "invlev_up": 798.29998779296875, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_363_generated", "manhole_dn": "manhole_364_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384230.112839305773377, 5856870.159957353956997 ], [ 1384259.121702386764809, 5856910.628996902145445 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E201", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 807.60003662109375, "invlev_up": 791.4000244140625, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_364_generated", "manhole_dn": "manhole_365_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384259.121702386764809, 5856910.628996902145445 ], [ 1384287.023718592710793, 5856951.925833041779697 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E202", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_365_generated", "manhole_dn": "manhole_366_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384287.023718592710793, 5856951.925833041779697 ], [ 1384314.929269487503916, 5856993.22028074786067 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E203", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_366_generated", "manhole_dn": "manhole_367_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384314.929269487503916, 5856993.22028074786067 ], [ 1384344.819752591196448, 5857033.056208833120763 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E204", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_367_generated", "manhole_dn": "manhole_368_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384344.819752591196448, 5857033.056208833120763 ], [ 1384375.891110281459987, 5857072.024425559677184 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E205", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_368_generated", "manhole_dn": "manhole_369_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384375.891110281459987, 5857072.024425559677184 ], [ 1384412.732155854580924, 5857105.507668288424611 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E206", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_369_generated", "manhole_dn": "manhole_370_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384412.732155854580924, 5857105.507668288424611 ], [ 1384450.07948348694481, 5857138.509612204506993 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E207", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_370_generated", "manhole_dn": "manhole_371_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384450.07948348694481, 5857138.509612204506993 ], [ 1384487.42686335532926, 5857171.511497005820274 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E208", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 805.0, "invlev_up": 793.4000244140625, "invlev_dn": 802.5, "manhole_up": "manhole_371_generated", "manhole_dn": "manhole_372_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384487.42686335532926, 5857171.511497005820274 ], [ 1384525.207759798038751, 5857204.014277670532465 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E209", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 796.29998779296875, "invlev_up": 802.5, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_372_generated", "manhole_dn": "manhole_373_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384525.207759798038751, 5857204.014277670532465 ], [ 1384563.111988977529109, 5857236.375065575353801 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E210", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 796.29998779296875, "invlev_up": 793.79998779296875, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_373_generated", "manhole_dn": "manhole_374_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384563.111988977529109, 5857236.375065575353801 ], [ 1384601.016218156786636, 5857268.735853480175138 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E211", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 786.10003662109375, "invlev_up": 793.79998779296875, "invlev_dn": 783.60003662109375, "manhole_up": "manhole_374_generated", "manhole_dn": "manhole_375_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384601.016218156786636, 5857268.735853480175138 ], [ 1384638.920447336044163, 5857301.096641384996474 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E212", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.10003662109375, "elevtn_dn": 794.29998779296875, "invlev_up": 783.60003662109375, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_375_generated", "manhole_dn": "manhole_376_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384638.920447336044163, 5857301.096641384996474 ], [ 1384669.604954990325496, 5857340.313404724933207 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E213", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 794.29998779296875, "invlev_up": 791.79998779296875, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_376_generated", "manhole_dn": "manhole_377_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384669.604954990325496, 5857340.313404724933207 ], [ 1384699.518247769214213, 5857380.104403200559318 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E214", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 794.29998779296875, "invlev_up": 791.79998779296875, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_377_generated", "manhole_dn": "manhole_378_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384699.518247769214213, 5857380.104403200559318 ], [ 1384719.806332413339987, 5857425.627417215146124 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E215", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 782.0, "invlev_up": 791.79998779296875, "invlev_dn": 779.5, "manhole_up": "manhole_378_generated", "manhole_dn": "manhole_379_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384719.806332413339987, 5857425.627417215146124 ], [ 1384740.094417057465762, 5857471.150431229732931 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E216", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 782.0, "elevtn_dn": 789.70001220703125, "invlev_up": 779.5, "invlev_dn": 787.20001220703125, "manhole_up": "manhole_379_generated", "manhole_dn": "manhole_380_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384740.094417057465762, 5857471.150431229732931 ], [ 1384760.382501701591536, 5857516.673445244319737 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E217", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 789.70001220703125, "elevtn_dn": 789.70001220703125, "invlev_up": 787.20001220703125, "invlev_dn": 787.20001220703125, "manhole_up": "manhole_380_generated", "manhole_dn": "manhole_381_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384760.382501701591536, 5857516.673445244319737 ], [ 1384780.670586345717311, 5857562.196459258906543 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E218", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 789.70001220703125, "elevtn_dn": 796.5, "invlev_up": 787.20001220703125, "invlev_dn": 794.0, "manhole_up": "manhole_381_generated", "manhole_dn": "manhole_382_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384780.670586345717311, 5857562.196459258906543 ], [ 1384802.672203443944454, 5857606.838341221213341 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E219", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.5, "elevtn_dn": 771.9000244140625, "invlev_up": 794.0, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_382_generated", "manhole_dn": "manhole_383_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384802.672203443944454, 5857606.838341221213341 ], [ 1384827.896526007680222, 5857649.823044718243182 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E220", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_383_generated", "manhole_dn": "manhole_384_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384827.896526007680222, 5857649.823044718243182 ], [ 1384854.757882944308221, 5857691.606820800341666 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E221", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_384_generated", "manhole_dn": "manhole_385_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384854.757882944308221, 5857691.606820800341666 ], [ 1384888.185768931638449, 5857728.573395187035203 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E222", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_385_generated", "manhole_dn": "manhole_386_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384888.185768931638449, 5857728.573395187035203 ], [ 1384921.613654918735847, 5857765.539969574660063 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E223", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 755.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_386_generated", "manhole_dn": "manhole_387_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384921.613654918735847, 5857765.539969574660063 ], [ 1384956.145453942706808, 5857801.445756647735834 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E224", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 755.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_387_generated", "manhole_dn": "manhole_388_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384956.145453942706808, 5857801.445756647735834 ], [ 1384991.751306539867073, 5857836.319449373520911 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E225", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 746.0, "invlev_up": 755.4000244140625, "invlev_dn": 743.5, "manhole_up": "manhole_388_generated", "manhole_dn": "manhole_389_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384991.751306539867073, 5857836.319449373520911 ], [ 1385027.357159137027338, 5857871.193142099305987 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E226", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 746.0, "elevtn_dn": 755.79998779296875, "invlev_up": 743.5, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_389_generated", "manhole_dn": "manhole_390_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385027.357159137027338, 5857871.193142099305987 ], [ 1385062.963011734187603, 5857906.066834825091064 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E227", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 728.60003662109375, "invlev_up": 753.29998779296875, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_390_generated", "manhole_dn": "manhole_391_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385062.963011734187603, 5857906.066834825091064 ], [ 1385098.568864331347868, 5857940.940527551807463 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E228", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 728.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_391_generated", "manhole_dn": "manhole_392_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385098.568864331347868, 5857940.940527551807463 ], [ 1385135.753846400883049, 5857974.029479116201401 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E229", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 728.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_392_generated", "manhole_dn": "manhole_393_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385135.753846400883049, 5857974.029479116201401 ], [ 1385175.738456205930561, 5858003.622975903563201 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E230", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 735.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 733.10003662109375, "manhole_up": "manhole_393_generated", "manhole_dn": "manhole_394_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385175.738456205930561, 5858003.622975903563201 ], [ 1385218.653756857383996, 5858028.965196672827005 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E231", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 735.60003662109375, "elevtn_dn": 735.60003662109375, "invlev_up": 733.10003662109375, "invlev_dn": 733.10003662109375, "manhole_up": "manhole_394_generated", "manhole_dn": "manhole_395_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385218.653756857383996, 5858028.965196672827005 ], [ 1385262.454936756985262, 5858052.706982978619635 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E232", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 735.60003662109375, "elevtn_dn": 742.0, "invlev_up": 733.10003662109375, "invlev_dn": 739.5, "manhole_up": "manhole_395_generated", "manhole_dn": "manhole_396_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385262.454936756985262, 5858052.706982978619635 ], [ 1385306.715555034345016, 5858075.618745312094688 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E233", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.0, "elevtn_dn": 742.0, "invlev_up": 739.5, "invlev_dn": 739.5, "manhole_up": "manhole_396_generated", "manhole_dn": "manhole_397_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385306.715555034345016, 5858075.618745312094688 ], [ 1385350.97617331170477, 5858098.530507644638419 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E234", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.0, "elevtn_dn": 736.0, "invlev_up": 739.5, "invlev_dn": 733.5, "manhole_up": "manhole_397_generated", "manhole_dn": "manhole_398_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385350.97617331170477, 5858098.530507644638419 ], [ 1385395.236791589297354, 5858121.442269978113472 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E235", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 736.0, "elevtn_dn": 736.0, "invlev_up": 733.5, "invlev_dn": 733.5, "manhole_up": "manhole_398_generated", "manhole_dn": "manhole_399_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385395.236791589297354, 5858121.442269978113472 ], [ 1385439.497409866657108, 5858144.354032310657203 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E236", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 736.0, "elevtn_dn": 737.9000244140625, "invlev_up": 733.5, "invlev_dn": 735.4000244140625, "manhole_up": "manhole_399_generated", "manhole_dn": "manhole_400_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385439.497409866657108, 5858144.354032310657203 ], [ 1385483.758028144016862, 5858167.265794644132257 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E237", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.9000244140625, "elevtn_dn": 737.9000244140625, "invlev_up": 735.4000244140625, "invlev_dn": 735.4000244140625, "manhole_up": "manhole_400_generated", "manhole_dn": "manhole_401_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385483.758028144016862, 5858167.265794644132257 ], [ 1385528.018646421376616, 5858190.17755697760731 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E238", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.9000244140625, "elevtn_dn": 727.29998779296875, "invlev_up": 735.4000244140625, "invlev_dn": 724.79998779296875, "manhole_up": "manhole_401_generated", "manhole_dn": "manhole_402_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385528.018646421376616, 5858190.17755697760731 ], [ 1385571.606102279853076, 5858214.277655217796564 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E239", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.29998779296875, "elevtn_dn": 727.29998779296875, "invlev_up": 724.79998779296875, "invlev_dn": 724.79998779296875, "manhole_up": "manhole_402_generated", "manhole_dn": "manhole_403_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385571.606102279853076, 5858214.277655217796564 ], [ 1385614.013400863157585, 5858240.461089110001922 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E240", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.29998779296875, "elevtn_dn": 690.60003662109375, "invlev_up": 724.79998779296875, "invlev_dn": 688.10003662109375, "manhole_up": "manhole_403_generated", "manhole_dn": "manhole_404_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385614.013400863157585, 5858240.461089110001922 ], [ 1385656.420699446462095, 5858266.644523002207279 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E241", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 690.60003662109375, "elevtn_dn": 733.60003662109375, "invlev_up": 688.10003662109375, "invlev_dn": 731.10003662109375, "manhole_up": "manhole_404_generated", "manhole_dn": "manhole_405_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385656.420699446462095, 5858266.644523002207279 ], [ 1385698.773111530812457, 5858292.8961898451671 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E242", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 733.60003662109375, "elevtn_dn": 733.60003662109375, "invlev_up": 731.10003662109375, "invlev_dn": 731.10003662109375, "manhole_up": "manhole_405_generated", "manhole_dn": "manhole_406_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385698.773111530812457, 5858292.8961898451671 ], [ 1385733.435650466475636, 5858328.707634637132287 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E243", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 733.60003662109375, "elevtn_dn": 721.60003662109375, "invlev_up": 731.10003662109375, "invlev_dn": 719.10003662109375, "manhole_up": "manhole_406_generated", "manhole_dn": "manhole_407_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385733.435650466475636, 5858328.707634637132287 ], [ 1385768.098189401905984, 5858364.519079428166151 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E244", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 721.60003662109375, "elevtn_dn": 721.60003662109375, "invlev_up": 719.10003662109375, "invlev_dn": 719.10003662109375, "manhole_up": "manhole_407_generated", "manhole_dn": "manhole_408_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385768.098189401905984, 5858364.519079428166151 ], [ 1385795.882535298354924, 5858405.467093757353723 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E245", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 721.60003662109375, "elevtn_dn": 739.0, "invlev_up": 719.10003662109375, "invlev_dn": 736.5, "manhole_up": "manhole_408_generated", "manhole_dn": "manhole_409_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385795.882535298354924, 5858405.467093757353723 ], [ 1385820.377634756267071, 5858448.871486231684685 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E246", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 727.79998779296875, "invlev_up": 736.5, "invlev_dn": 725.29998779296875, "manhole_up": "manhole_409_generated", "manhole_dn": "manhole_410_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385820.377634756267071, 5858448.871486231684685 ], [ 1385841.084314390551299, 5858493.920932004228234 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E247", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.79998779296875, "elevtn_dn": 727.79998779296875, "invlev_up": 725.29998779296875, "invlev_dn": 725.29998779296875, "manhole_up": "manhole_410_generated", "manhole_dn": "manhole_411_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385841.084314390551299, 5858493.920932004228234 ], [ 1385856.076261736918241, 5858541.451897682622075 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E248", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.79998779296875, "elevtn_dn": 734.9000244140625, "invlev_up": 725.29998779296875, "invlev_dn": 732.4000244140625, "manhole_up": "manhole_411_generated", "manhole_dn": "manhole_412_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385856.076261736918241, 5858541.451897682622075 ], [ 1385865.668899663724005, 5858590.250006795860827 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E249", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 734.9000244140625, "elevtn_dn": 734.9000244140625, "invlev_up": 732.4000244140625, "invlev_dn": 732.4000244140625, "manhole_up": "manhole_412_generated", "manhole_dn": "manhole_413_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385865.668899663724005, 5858590.250006795860827 ], [ 1385873.387286560609937, 5858639.487976770848036 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E250", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 734.9000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 732.4000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_413_generated", "manhole_dn": "manhole_414_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385873.387286560609937, 5858639.487976770848036 ], [ 1385875.017949819331989, 5858689.287253175862134 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E251", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 748.9000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_414_generated", "manhole_dn": "manhole_415_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385875.017949819331989, 5858689.287253175862134 ], [ 1385876.432928551919758, 5858739.106416343711317 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E252", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 748.9000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_415_generated", "manhole_dn": "manhole_416_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385876.432928551919758, 5858739.106416343711317 ], [ 1385878.329821793129668, 5858788.908141564577818 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E253", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 748.9000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_416_generated", "manhole_dn": "manhole_417_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385878.329821793129668, 5858788.908141564577818 ], [ 1385880.51921496167779, 5858838.69928275514394 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E254", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_417_generated", "manhole_dn": "manhole_418_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385880.51921496167779, 5858838.69928275514394 ], [ 1385882.620351102668792, 5858888.493530485779047 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E255", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_418_generated", "manhole_dn": "manhole_419_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385882.620351102668792, 5858888.493530485779047 ], [ 1385883.937443709466606, 5858938.315377607010305 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E256", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 766.10003662109375, "invlev_up": 757.20001220703125, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_419_generated", "manhole_dn": "manhole_420_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385883.937443709466606, 5858938.315377607010305 ], [ 1385885.254538560518995, 5858988.137224668636918 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E257", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 766.10003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_420_generated", "manhole_dn": "manhole_421_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385885.254538560518995, 5858988.137224668636918 ], [ 1385890.650534195825458, 5859037.630400610156357 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E258", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 766.10003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_421_generated", "manhole_dn": "manhole_422_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385890.650534195825458, 5859037.630400610156357 ], [ 1385901.777442803606391, 5859086.09239396546036 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E259", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 768.60003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 766.10003662109375, "manhole_up": "manhole_422_generated", "manhole_dn": "manhole_423_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385901.777442803606391, 5859086.09239396546036 ], [ 1385915.397954803425819, 5859134.03436760418117 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E260", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.60003662109375, "elevtn_dn": 762.79998779296875, "invlev_up": 766.10003662109375, "invlev_dn": 760.29998779296875, "manhole_up": "manhole_423_generated", "manhole_dn": "manhole_424_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385915.397954803425819, 5859134.03436760418117 ], [ 1385928.42605347908102, 5859182.139209139160812 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E261", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.79998779296875, "elevtn_dn": 762.5, "invlev_up": 760.29998779296875, "invlev_dn": 760.0, "manhole_up": "manhole_424_generated", "manhole_dn": "manhole_425_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385928.42605347908102, 5859182.139209139160812 ], [ 1385941.228082312969491, 5859230.306202415376902 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E262", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 762.5, "invlev_up": 760.0, "invlev_dn": 760.0, "manhole_up": "manhole_425_generated", "manhole_dn": "manhole_426_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385941.228082312969491, 5859230.306202415376902 ], [ 1385945.092689140234143, 5859279.734331246465445 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E263", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 762.5, "invlev_up": 760.0, "invlev_dn": 760.0, "manhole_up": "manhole_426_generated", "manhole_dn": "manhole_427_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385945.092689140234143, 5859279.734331246465445 ], [ 1385937.902412303024903, 5859328.779896341264248 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E264", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 778.0, "invlev_up": 760.0, "invlev_dn": 775.5, "manhole_up": "manhole_427_generated", "manhole_dn": "manhole_428_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.902412303024903, 5859328.779896341264248 ], [ 1385932.795075723901391, 5859378.173214216716588 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E265", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 778.0, "invlev_up": 775.5, "invlev_dn": 775.5, "manhole_up": "manhole_428_generated", "manhole_dn": "manhole_429_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385932.795075723901391, 5859378.173214216716588 ], [ 1385937.702695531537756, 5859427.770254967734218 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E266", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 778.0, "invlev_up": 775.5, "invlev_dn": 775.5, "manhole_up": "manhole_429_generated", "manhole_dn": "manhole_430_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.702695531537756, 5859427.770254967734218 ], [ 1385939.035937832202762, 5859477.50230407807976 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E267", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 795.9000244140625, "invlev_up": 775.5, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_430_generated", "manhole_dn": "manhole_431_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385939.035937832202762, 5859477.50230407807976 ], [ 1385937.883638251805678, 5859527.328234969638288 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E268", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_431_generated", "manhole_dn": "manhole_432_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.883638251805678, 5859527.328234969638288 ], [ 1385940.515994266141206, 5859576.989168248139322 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E269", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_432_generated", "manhole_dn": "manhole_433_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385940.515994266141206, 5859576.989168248139322 ], [ 1385950.701545101590455, 5859625.530176519416273 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E270", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 815.0, "invlev_up": 793.4000244140625, "invlev_dn": 812.5, "manhole_up": "manhole_433_generated", "manhole_dn": "manhole_434_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385950.701545101590455, 5859625.530176519416273 ], [ 1385970.467743494315073, 5859670.991298755630851 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E271", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 815.0, "elevtn_dn": 815.0, "invlev_up": 812.5, "invlev_dn": 812.5, "manhole_up": "manhole_434_generated", "manhole_dn": "manhole_435_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385970.467743494315073, 5859670.991298755630851 ], [ 1386011.983088220236823, 5859697.862916950136423 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E272", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 815.0, "elevtn_dn": 779.79998779296875, "invlev_up": 812.5, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_435_generated", "manhole_dn": "manhole_436_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386011.983088220236823, 5859697.862916950136423 ], [ 1386052.213596233632416, 5859727.119808158837259 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E273", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_436_generated", "manhole_dn": "manhole_437_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386052.213596233632416, 5859727.119808158837259 ], [ 1386046.501012831227854, 5859771.612671964801848 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E274", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_437_generated", "manhole_dn": "manhole_438_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386046.501012831227854, 5859771.612671964801848 ], [ 1386026.809695787727833, 5859816.873920152895153 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E275", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_438_generated", "manhole_dn": "manhole_439_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386026.809695787727833, 5859816.873920152895153 ], [ 1386030.149607364553958, 5859866.379009906202555 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_10_E276", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_439_generated", "manhole_dn": "manhole_440_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386030.149607364553958, 5859866.379009906202555 ], [ 1386045.250939248362556, 5859913.859036295674741 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_11_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 798.29998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_441_generated", "manhole_dn": "manhole_442_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384196.861816460033879, 5856829.88048410974443 ], [ 1384235.22519311751239, 5856854.977665597572923 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_11_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 793.9000244140625, "invlev_up": 798.29998779296875, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_442_generated", "manhole_dn": "manhole_443_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384235.22519311751239, 5856854.977665597572923 ], [ 1384263.450329831801355, 5856892.038370934315026 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_11_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 793.9000244140625, "invlev_up": 791.4000244140625, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_443_generated", "manhole_dn": "manhole_444_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384263.450329831801355, 5856892.038370934315026 ], [ 1384291.675466545857489, 5856929.099076271057129 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_11_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 807.60003662109375, "invlev_up": 791.4000244140625, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_444_generated", "manhole_dn": "manhole_445_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384291.675466545857489, 5856929.099076271057129 ], [ 1384319.900603260146454, 5856966.159781608730555 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_11_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_445_generated", "manhole_dn": "manhole_446_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384319.900603260146454, 5856966.159781608730555 ], [ 1384347.205867683747783, 5857003.894510924816132 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_11_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 799.0, "invlev_up": 805.10003662109375, "invlev_dn": 796.5, "manhole_up": "manhole_446_generated", "manhole_dn": "manhole_447_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384347.205867683747783, 5857003.894510924816132 ], [ 1384380.322691001230851, 5857036.360282040201128 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_11_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 799.0, "elevtn_dn": 807.60003662109375, "invlev_up": 796.5, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_447_generated", "manhole_dn": "manhole_448_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384380.322691001230851, 5857036.360282040201128 ], [ 1384415.156610523350537, 5857067.291694445535541 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_11_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_448_generated", "manhole_dn": "manhole_449_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384415.156610523350537, 5857067.291694445535541 ], [ 1384449.343575850594789, 5857098.828100205399096 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_11_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_449_generated", "manhole_dn": "manhole_450_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384449.343575850594789, 5857098.828100205399096 ], [ 1384470.004810179118067, 5857139.926174183376133 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_11_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_450_generated", "manhole_dn": "manhole_451_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384470.004810179118067, 5857139.926174183376133 ], [ 1384484.18076178082265, 5857184.301805094815791 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_12_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_452_generated", "manhole_dn": "manhole_453_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384289.06552429520525, 5856954.947841017507017 ], [ 1384305.049610810354352, 5856994.88734863139689 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_12_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_453_generated", "manhole_dn": "manhole_454_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384305.049610810354352, 5856994.88734863139689 ], [ 1384321.033697325503454, 5857034.82685624435544 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_12_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 799.0, "invlev_up": 805.10003662109375, "invlev_dn": 796.5, "manhole_up": "manhole_454_generated", "manhole_dn": "manhole_455_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384321.033697325503454, 5857034.82685624435544 ], [ 1384347.445656489115208, 5857068.672038841992617 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_12_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 799.0, "elevtn_dn": 807.60003662109375, "invlev_up": 796.5, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_455_generated", "manhole_dn": "manhole_456_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384347.445656489115208, 5857068.672038841992617 ], [ 1384374.130628447979689, 5857102.406951548531651 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_12_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_456_generated", "manhole_dn": "manhole_457_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384374.130628447979689, 5857102.406951548531651 ], [ 1384399.587644136510789, 5857137.08541233278811 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_12_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_457_generated", "manhole_dn": "manhole_458_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384399.587644136510789, 5857137.08541233278811 ], [ 1384425.04465982504189, 5857171.763873117044568 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_12_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_458_generated", "manhole_dn": "manhole_459_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384425.04465982504189, 5857171.763873117044568 ], [ 1384456.866520966170356, 5857200.577977900393307 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_15_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_15", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_15", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_459_generated", "manhole_dn": "manhole_460_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384456.866520966170356, 5857200.577977900393307 ], [ 1384480.774830641923472, 5857195.244455400854349 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_17_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_17", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_17", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 805.0, "invlev_up": 793.4000244140625, "invlev_dn": 802.5, "manhole_up": "manhole_459_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384456.866520966170356, 5857200.577977900393307 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_18_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_18", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_18", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_462_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384493.329776774393395, 5857201.952337642200291 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_19_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_19", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_19", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_462_generated", "manhole_dn": "manhole_463_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384493.329776774393395, 5857201.952337642200291 ], [ 1384511.321100181667134, 5857246.008046119473875 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_19_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_19", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_19", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_463_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384511.321100181667134, 5857246.008046119473875 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 796.29998779296875, "invlev_up": 802.5, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_464_generated", "manhole_dn": "manhole_465_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384512.484966830350459, 5857248.858029337599874 ], [ 1384550.208547196350992, 5857281.609186780638993 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 796.29998779296875, "invlev_up": 793.79998779296875, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_465_generated", "manhole_dn": "manhole_466_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384550.208547196350992, 5857281.609186780638993 ], [ 1384587.932127562351525, 5857314.360344224609435 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 809.10003662109375, "invlev_up": 793.79998779296875, "invlev_dn": 806.60003662109375, "manhole_up": "manhole_466_generated", "manhole_dn": "manhole_467_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384587.932127562351525, 5857314.360344224609435 ], [ 1384608.456866907887161, 5857358.785165345296264 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.10003662109375, "elevtn_dn": 809.10003662109375, "invlev_up": 806.60003662109375, "invlev_dn": 806.60003662109375, "manhole_up": "manhole_467_generated", "manhole_dn": "manhole_468_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384608.456866907887161, 5857358.785165345296264 ], [ 1384624.966163935838267, 5857405.935456342995167 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.10003662109375, "elevtn_dn": 794.29998779296875, "invlev_up": 806.60003662109375, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_468_generated", "manhole_dn": "manhole_469_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384624.966163935838267, 5857405.935456342995167 ], [ 1384639.938245237572119, 5857453.586039477027953 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 812.4000244140625, "invlev_up": 791.79998779296875, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_469_generated", "manhole_dn": "manhole_470_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384639.938245237572119, 5857453.586039477027953 ], [ 1384654.3423755497206, 5857501.421464210376143 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 812.4000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_470_generated", "manhole_dn": "manhole_471_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384654.3423755497206, 5857501.421464210376143 ], [ 1384665.748858094681054, 5857550.055336253717542 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 812.4000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_471_generated", "manhole_dn": "manhole_472_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384665.748858094681054, 5857550.055336253717542 ], [ 1384677.04772660904564, 5857598.717872150242329 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 818.9000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 816.4000244140625, "manhole_up": "manhole_472_generated", "manhole_dn": "manhole_473_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384677.04772660904564, 5857598.717872150242329 ], [ 1384688.346595123410225, 5857647.380408045835793 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.9000244140625, "elevtn_dn": 818.9000244140625, "invlev_up": 816.4000244140625, "invlev_dn": 816.4000244140625, "manhole_up": "manhole_473_generated", "manhole_dn": "manhole_474_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384688.346595123410225, 5857647.380408045835793 ], [ 1384699.64546363777481, 5857696.042943941429257 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.9000244140625, "elevtn_dn": 791.0, "invlev_up": 816.4000244140625, "invlev_dn": 788.5, "manhole_up": "manhole_474_generated", "manhole_dn": "manhole_475_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384699.64546363777481, 5857696.042943941429257 ], [ 1384710.944332152139395, 5857744.705479837954044 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 771.9000244140625, "invlev_up": 788.5, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_475_generated", "manhole_dn": "manhole_476_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384710.944332152139395, 5857744.705479837954044 ], [ 1384726.848783193388954, 5857791.671307560056448 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_476_generated", "manhole_dn": "manhole_477_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384726.848783193388954, 5857791.671307560056448 ], [ 1384753.929338480113074, 5857833.199649352580309 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_477_generated", "manhole_dn": "manhole_478_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384753.929338480113074, 5857833.199649352580309 ], [ 1384783.627482200739905, 5857873.006575288251042 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 791.0, "invlev_up": 769.4000244140625, "invlev_dn": 788.5, "manhole_up": "manhole_478_generated", "manhole_dn": "manhole_479_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384783.627482200739905, 5857873.006575288251042 ], [ 1384795.018452654592693, 5857920.637507135979831 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 791.0, "invlev_up": 788.5, "invlev_dn": 788.5, "manhole_up": "manhole_479_generated", "manhole_dn": "manhole_480_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384795.018452654592693, 5857920.637507135979831 ], [ 1384785.075932276435196, 5857969.445633230730891 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 820.10003662109375, "invlev_up": 788.5, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_480_generated", "manhole_dn": "manhole_481_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384785.075932276435196, 5857969.445633230730891 ], [ 1384771.479073295136914, 5858017.516749874688685 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 820.10003662109375, "invlev_up": 817.60003662109375, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_481_generated", "manhole_dn": "manhole_482_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384771.479073295136914, 5858017.516749874688685 ], [ 1384763.32518996251747, 5858066.675425447523594 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 820.10003662109375, "invlev_up": 817.60003662109375, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_482_generated", "manhole_dn": "manhole_483_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384763.32518996251747, 5858066.675425447523594 ], [ 1384757.405406558187678, 5858116.280495692044497 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 847.0, "invlev_up": 817.60003662109375, "invlev_dn": 844.5, "manhole_up": "manhole_483_generated", "manhole_dn": "manhole_484_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384757.405406558187678, 5858116.280495692044497 ], [ 1384746.211964494548738, 5858164.956996791996062 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 847.0, "invlev_up": 844.5, "invlev_dn": 844.5, "manhole_up": "manhole_484_generated", "manhole_dn": "manhole_485_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384746.211964494548738, 5858164.956996791996062 ], [ 1384738.028054837835953, 5858213.862443570047617 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 847.0, "invlev_up": 844.5, "invlev_dn": 844.5, "manhole_up": "manhole_485_generated", "manhole_dn": "manhole_486_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384738.028054837835953, 5858213.862443570047617 ], [ 1384756.479259133106098, 5858259.218586039729416 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 833.20001220703125, "invlev_up": 844.5, "invlev_dn": 830.70001220703125, "manhole_up": "manhole_486_generated", "manhole_dn": "manhole_487_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384756.479259133106098, 5858259.218586039729416 ], [ 1384792.653981153853238, 5858293.25339647103101 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 833.20001220703125, "elevtn_dn": 762.29998779296875, "invlev_up": 830.70001220703125, "invlev_dn": 759.79998779296875, "manhole_up": "manhole_487_generated", "manhole_dn": "manhole_488_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384792.653981153853238, 5858293.25339647103101 ], [ 1384839.146884107263759, 5858310.949097327888012 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.29998779296875, "elevtn_dn": 762.29998779296875, "invlev_up": 759.79998779296875, "invlev_dn": 759.79998779296875, "manhole_up": "manhole_488_generated", "manhole_dn": "manhole_489_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384839.146884107263759, 5858310.949097327888012 ], [ 1384888.517509665805846, 5858307.535864246077836 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.29998779296875, "elevtn_dn": 751.0, "invlev_up": 759.79998779296875, "invlev_dn": 748.5, "manhole_up": "manhole_489_generated", "manhole_dn": "manhole_490_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384888.517509665805846, 5858307.535864246077836 ], [ 1384936.622762819286436, 5858294.068231076002121 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.0, "elevtn_dn": 751.0, "invlev_up": 748.5, "invlev_dn": 748.5, "manhole_up": "manhole_490_generated", "manhole_dn": "manhole_491_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384936.622762819286436, 5858294.068231076002121 ], [ 1384984.637113286415115, 5858280.272530450485647 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.0, "elevtn_dn": 743.20001220703125, "invlev_up": 748.5, "invlev_dn": 740.70001220703125, "manhole_up": "manhole_491_generated", "manhole_dn": "manhole_492_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384984.637113286415115, 5858280.272530450485647 ], [ 1385032.633651287527755, 5858266.414710656739771 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 743.20001220703125, "elevtn_dn": 743.20001220703125, "invlev_up": 740.70001220703125, "invlev_dn": 740.70001220703125, "manhole_up": "manhole_492_generated", "manhole_dn": "manhole_493_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385032.633651287527755, 5858266.414710656739771 ], [ 1385081.886840383987874, 5858258.136644747108221 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 743.20001220703125, "elevtn_dn": 747.60003662109375, "invlev_up": 740.70001220703125, "invlev_dn": 745.10003662109375, "manhole_up": "manhole_493_generated", "manhole_dn": "manhole_494_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385081.886840383987874, 5858258.136644747108221 ], [ 1385131.310463621048257, 5858263.211211345158517 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.60003662109375, "elevtn_dn": 756.79998779296875, "invlev_up": 745.10003662109375, "invlev_dn": 754.29998779296875, "manhole_up": "manhole_494_generated", "manhole_dn": "manhole_495_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385131.310463621048257, 5858263.211211345158517 ], [ 1385177.729395114118233, 5858281.168494092300534 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.79998779296875, "elevtn_dn": 758.9000244140625, "invlev_up": 754.29998779296875, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_495_generated", "manhole_dn": "manhole_496_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385177.729395114118233, 5858281.168494092300534 ], [ 1385219.95651927171275, 5858307.84242575801909 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 758.9000244140625, "invlev_up": 756.4000244140625, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_496_generated", "manhole_dn": "manhole_497_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385219.95651927171275, 5858307.84242575801909 ], [ 1385261.864506913116202, 5858335.034840167500079 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 756.29998779296875, "invlev_up": 756.4000244140625, "invlev_dn": 753.79998779296875, "manhole_up": "manhole_497_generated", "manhole_dn": "manhole_498_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385261.864506913116202, 5858335.034840167500079 ], [ 1385305.658712412696332, 5858358.964500648900867 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 756.29998779296875, "invlev_up": 753.79998779296875, "invlev_dn": 753.79998779296875, "manhole_up": "manhole_498_generated", "manhole_dn": "manhole_499_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385305.658712412696332, 5858358.964500648900867 ], [ 1385350.136275847908109, 5858381.712097893469036 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 750.79998779296875, "invlev_up": 753.79998779296875, "invlev_dn": 748.29998779296875, "manhole_up": "manhole_499_generated", "manhole_dn": "manhole_500_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385350.136275847908109, 5858381.712097893469036 ], [ 1385394.617425152566284, 5858404.452682325616479 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 750.79998779296875, "elevtn_dn": 760.20001220703125, "invlev_up": 748.29998779296875, "invlev_dn": 757.70001220703125, "manhole_up": "manhole_500_generated", "manhole_dn": "manhole_501_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385394.617425152566284, 5858404.452682325616479 ], [ 1385439.245915542822331, 5858426.901898948475718 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 760.20001220703125, "elevtn_dn": 754.29998779296875, "invlev_up": 757.70001220703125, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_501_generated", "manhole_dn": "manhole_502_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385439.245915542822331, 5858426.901898948475718 ], [ 1385483.926139793125913, 5858449.248809035867453 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 754.29998779296875, "invlev_up": 751.79998779296875, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_502_generated", "manhole_dn": "manhole_503_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385483.926139793125913, 5858449.248809035867453 ], [ 1385525.860647091642022, 5858475.8632338559255 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 754.29998779296875, "invlev_up": 751.79998779296875, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_503_generated", "manhole_dn": "manhole_504_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385525.860647091642022, 5858475.8632338559255 ], [ 1385553.357332118786871, 5858517.404887572862208 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 751.70001220703125, "invlev_up": 751.79998779296875, "invlev_dn": 749.20001220703125, "manhole_up": "manhole_504_generated", "manhole_dn": "manhole_505_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385553.357332118786871, 5858517.404887572862208 ], [ 1385579.617479301057756, 5858559.686364834196866 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.70001220703125, "elevtn_dn": 751.70001220703125, "invlev_up": 749.20001220703125, "invlev_dn": 749.20001220703125, "manhole_up": "manhole_505_generated", "manhole_dn": "manhole_506_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385579.617479301057756, 5858559.686364834196866 ], [ 1385621.905693766893819, 5858585.068030893802643 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.70001220703125, "elevtn_dn": 750.9000244140625, "invlev_up": 749.20001220703125, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_506_generated", "manhole_dn": "manhole_507_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385621.905693766893819, 5858585.068030893802643 ], [ 1385664.027273919200525, 5858611.351026647724211 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 750.9000244140625, "invlev_up": 748.4000244140625, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_507_generated", "manhole_dn": "manhole_508_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385664.027273919200525, 5858611.351026647724211 ], [ 1385700.387205619364977, 5858645.507954810746014 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 750.9000244140625, "invlev_up": 748.4000244140625, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_508_generated", "manhole_dn": "manhole_509_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385700.387205619364977, 5858645.507954810746014 ], [ 1385734.601841112133116, 5858681.909404612146318 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 755.79998779296875, "invlev_up": 748.4000244140625, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_509_generated", "manhole_dn": "manhole_510_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385734.601841112133116, 5858681.909404612146318 ], [ 1385768.816476604901254, 5858718.310854412615299 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_510_generated", "manhole_dn": "manhole_511_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385768.816476604901254, 5858718.310854412615299 ], [ 1385802.200311921536922, 5858755.447309947572649 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_20_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_511_generated", "manhole_dn": "manhole_512_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385802.200311921536922, 5858755.447309947572649 ], [ 1385834.15946239954792, 5858793.844178703613579 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_21_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 765.0, "invlev_up": 753.79998779296875, "invlev_dn": 762.5, "manhole_up": "manhole_513_generated", "manhole_dn": "manhole_514_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385352.471788094611838, 5858398.70255031902343 ], [ 1385323.609449510695413, 5858430.098599229939282 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_21_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.0, "elevtn_dn": 765.0, "invlev_up": 762.5, "invlev_dn": 762.5, "manhole_up": "manhole_514_generated", "manhole_dn": "manhole_515_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385323.609449510695413, 5858430.098599229939282 ], [ 1385286.388775944709778, 5858419.306091710925102 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_21_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.0, "elevtn_dn": 758.9000244140625, "invlev_up": 762.5, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_515_generated", "manhole_dn": "manhole_516_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385286.388775944709778, 5858419.306091710925102 ], [ 1385252.458742934046313, 5858394.201654580421746 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_21_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 758.9000244140625, "invlev_up": 756.4000244140625, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_516_generated", "manhole_dn": "manhole_517_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385252.458742934046313, 5858394.201654580421746 ], [ 1385217.536378393415362, 5858369.72360460460186 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_21_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 756.79998779296875, "invlev_up": 756.4000244140625, "invlev_dn": 754.29998779296875, "manhole_up": "manhole_517_generated", "manhole_dn": "manhole_518_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385217.536378393415362, 5858369.72360460460186 ], [ 1385177.877519500209019, 5858363.975667187944055 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_23_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_23", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "manhole_up": "manhole_519_generated", "manhole_dn": "manhole_520_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384748.107251951703802, 5858475.46539437584579 ], [ 1384773.662756133358926, 5858482.028828926384449 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_23_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_23", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "manhole_up": "manhole_520_generated", "manhole_dn": "manhole_521_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384773.662756133358926, 5858482.028828926384449 ], [ 1384799.21826031524688, 5858488.592263477854431 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_24_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_24", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_24", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.9000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 760.4000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_522_generated", "manhole_dn": "manhole_523_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385831.554474999429658, 5858837.476550582796335 ], [ 1385834.933234154479578, 5858795.367517679929733 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_24_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_24", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_24", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 748.9000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_523_generated", "manhole_dn": "manhole_524_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385834.933234154479578, 5858795.367517679929733 ], [ 1385855.640895856311545, 5858836.135079927742481 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_25_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_25", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.79998779296875, "elevtn_dn": 791.20001220703125, "invlev_up": 784.29998779296875, "invlev_dn": 788.70001220703125, "manhole_up": "manhole_525_generated", "manhole_dn": "manhole_526_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385425.871741503709927, 5858809.522038951516151 ], [ 1385446.216239683330059, 5858844.397748519666493 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_25_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_25", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.20001220703125, "elevtn_dn": 791.20001220703125, "invlev_up": 788.70001220703125, "invlev_dn": 788.70001220703125, "manhole_up": "manhole_526_generated", "manhole_dn": "manhole_527_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385446.216239683330059, 5858844.397748519666493 ], [ 1385453.998638280900195, 5858886.437654017470777 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_25_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_25", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.20001220703125, "elevtn_dn": 783.0, "invlev_up": 788.70001220703125, "invlev_dn": 780.5, "manhole_up": "manhole_527_generated", "manhole_dn": "manhole_528_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385453.998638280900195, 5858886.437654017470777 ], [ 1385472.218053022632375, 5858925.273072509095073 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_26_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_26", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_26", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.9000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 760.4000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_522_generated", "manhole_dn": "manhole_524_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385831.554474999429658, 5858837.476550582796335 ], [ 1385855.640895856311545, 5858836.135079927742481 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_29_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_29", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_29", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_529_generated", "manhole_dn": "manhole_530_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385861.372513797832653, 5858893.832569030113518 ], [ 1385844.630084188189358, 5858865.848266057670116 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_29_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_29", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_29", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 762.9000244140625, "invlev_up": 757.20001220703125, "invlev_dn": 760.4000244140625, "manhole_up": "manhole_530_generated", "manhole_dn": "manhole_522_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385844.630084188189358, 5858865.848266057670116 ], [ 1385831.554474999429658, 5858837.476550582796335 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_30_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 769.4000244140625, "invlev_up": 766.9000244140625, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_531_generated", "manhole_dn": "manhole_532_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387137.22300889948383, 5858981.723106959834695 ], [ 1387148.04859330272302, 5859026.366797789931297 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_30_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 762.60003662109375, "invlev_up": 766.9000244140625, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_532_generated", "manhole_dn": "manhole_533_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387148.04859330272302, 5859026.366797789931297 ], [ 1387119.95937648974359, 5859056.934598693624139 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_30_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 762.60003662109375, "invlev_up": 760.10003662109375, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_533_generated", "manhole_dn": "manhole_534_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387119.95937648974359, 5859056.934598693624139 ], [ 1387074.832296247361228, 5859065.30100557859987 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_30_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 755.79998779296875, "invlev_up": 760.10003662109375, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_534_generated", "manhole_dn": "manhole_535_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387074.832296247361228, 5859065.30100557859987 ], [ 1387030.356415221933275, 5859076.86137125454843 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_30_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 772.4000244140625, "invlev_up": 753.29998779296875, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_535_generated", "manhole_dn": "manhole_536_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387030.356415221933275, 5859076.86137125454843 ], [ 1386986.427998587489128, 5859090.309648380614817 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_30_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 761.60003662109375, "invlev_up": 769.9000244140625, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_536_generated", "manhole_dn": "manhole_537_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386986.427998587489128, 5859090.309648380614817 ], [ 1386945.966695382725447, 5859111.788386604748666 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_30_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_537_generated", "manhole_dn": "manhole_538_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386945.966695382725447, 5859111.788386604748666 ], [ 1386905.77102447184734, 5859134.105928846634924 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_30_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_538_generated", "manhole_dn": "manhole_539_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386905.77102447184734, 5859134.105928846634924 ], [ 1386871.537448140559718, 5859162.609670763835311 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_539_generated", "manhole_dn": "manhole_540_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386871.537448140559718, 5859162.609670763835311 ], [ 1386921.106019288301468, 5859163.103915391489863 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 772.4000244140625, "invlev_up": 759.10003662109375, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_540_generated", "manhole_dn": "manhole_541_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386921.106019288301468, 5859163.103915391489863 ], [ 1386970.627896018791944, 5859161.624508504755795 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 772.4000244140625, "invlev_up": 769.9000244140625, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_541_generated", "manhole_dn": "manhole_542_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386970.627896018791944, 5859161.624508504755795 ], [ 1387019.993600395740941, 5859157.412991388700902 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 781.10003662109375, "invlev_up": 769.9000244140625, "invlev_dn": 778.60003662109375, "manhole_up": "manhole_542_generated", "manhole_dn": "manhole_543_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387019.993600395740941, 5859157.412991388700902 ], [ 1387069.191225855611265, 5859151.340004274621606 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 781.10003662109375, "elevtn_dn": 781.10003662109375, "invlev_up": 778.60003662109375, "invlev_dn": 778.60003662109375, "manhole_up": "manhole_543_generated", "manhole_dn": "manhole_544_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387069.191225855611265, 5859151.340004274621606 ], [ 1387118.547863835236058, 5859146.828392788767815 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 781.10003662109375, "elevtn_dn": 786.4000244140625, "invlev_up": 778.60003662109375, "invlev_dn": 783.9000244140625, "manhole_up": "manhole_544_generated", "manhole_dn": "manhole_545_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387118.547863835236058, 5859146.828392788767815 ], [ 1387167.916038708761334, 5859151.025294326245785 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.4000244140625, "elevtn_dn": 786.4000244140625, "invlev_up": 783.9000244140625, "invlev_dn": 783.9000244140625, "manhole_up": "manhole_545_generated", "manhole_dn": "manhole_546_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387167.916038708761334, 5859151.025294326245785 ], [ 1387217.282604865729809, 5859155.523034786805511 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.4000244140625, "elevtn_dn": 787.60003662109375, "invlev_up": 783.9000244140625, "invlev_dn": 785.10003662109375, "manhole_up": "manhole_546_generated", "manhole_dn": "manhole_547_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387217.282604865729809, 5859155.523034786805511 ], [ 1387266.649171022465453, 5859160.020775248296559 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.60003662109375, "elevtn_dn": 787.60003662109375, "invlev_up": 785.10003662109375, "invlev_dn": 785.10003662109375, "manhole_up": "manhole_547_generated", "manhole_dn": "manhole_548_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387266.649171022465453, 5859160.020775248296559 ], [ 1387315.831188223091885, 5859165.716172898188233 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.60003662109375, "elevtn_dn": 790.4000244140625, "invlev_up": 785.10003662109375, "invlev_dn": 787.9000244140625, "manhole_up": "manhole_548_generated", "manhole_dn": "manhole_549_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387315.831188223091885, 5859165.716172898188233 ], [ 1387364.261764668161049, 5859176.288154195994139 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 790.4000244140625, "elevtn_dn": 790.4000244140625, "invlev_up": 787.9000244140625, "invlev_dn": 787.9000244140625, "manhole_up": "manhole_549_generated", "manhole_dn": "manhole_550_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387364.261764668161049, 5859176.288154195994139 ], [ 1387411.186259990092367, 5859192.118345031514764 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 790.4000244140625, "elevtn_dn": 789.10003662109375, "invlev_up": 787.9000244140625, "invlev_dn": 786.60003662109375, "manhole_up": "manhole_550_generated", "manhole_dn": "manhole_551_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387411.186259990092367, 5859192.118345031514764 ], [ 1387455.544592748628929, 5859213.906051598489285 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 789.10003662109375, "elevtn_dn": 817.20001220703125, "invlev_up": 786.60003662109375, "invlev_dn": 814.70001220703125, "manhole_up": "manhole_551_generated", "manhole_dn": "manhole_552_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387455.544592748628929, 5859213.906051598489285 ], [ 1387490.610425172373652, 5859248.94134864397347 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 817.20001220703125, "elevtn_dn": 818.20001220703125, "invlev_up": 814.70001220703125, "invlev_dn": 815.70001220703125, "manhole_up": "manhole_552_generated", "manhole_dn": "manhole_553_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387490.610425172373652, 5859248.94134864397347 ], [ 1387525.979065561201423, 5859283.669168318621814 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.20001220703125, "elevtn_dn": 818.20001220703125, "invlev_up": 815.70001220703125, "invlev_dn": 815.70001220703125, "manhole_up": "manhole_553_generated", "manhole_dn": "manhole_554_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387525.979065561201423, 5859283.669168318621814 ], [ 1387563.532416822388768, 5859316.0270627560094 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.20001220703125, "elevtn_dn": 802.79998779296875, "invlev_up": 815.70001220703125, "invlev_dn": 800.29998779296875, "manhole_up": "manhole_554_generated", "manhole_dn": "manhole_555_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387563.532416822388768, 5859316.0270627560094 ], [ 1387601.085768083808944, 5859348.384957193396986 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.79998779296875, "elevtn_dn": 837.70001220703125, "invlev_up": 800.29998779296875, "invlev_dn": 835.20001220703125, "manhole_up": "manhole_555_generated", "manhole_dn": "manhole_556_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387601.085768083808944, 5859348.384957193396986 ], [ 1387638.639119345229119, 5859380.742851630784571 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 837.70001220703125, "elevtn_dn": 837.70001220703125, "invlev_up": 835.20001220703125, "invlev_dn": 835.20001220703125, "manhole_up": "manhole_556_generated", "manhole_dn": "manhole_557_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387638.639119345229119, 5859380.742851630784571 ], [ 1387676.192470606416464, 5859413.100746068172157 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 837.70001220703125, "elevtn_dn": 828.79998779296875, "invlev_up": 835.20001220703125, "invlev_dn": 826.29998779296875, "manhole_up": "manhole_557_generated", "manhole_dn": "manhole_558_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387676.192470606416464, 5859413.100746068172157 ], [ 1387713.745821867836639, 5859445.45864050462842 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 828.79998779296875, "elevtn_dn": 828.79998779296875, "invlev_up": 826.29998779296875, "invlev_dn": 826.29998779296875, "manhole_up": "manhole_558_generated", "manhole_dn": "manhole_559_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387713.745821867836639, 5859445.45864050462842 ], [ 1387750.394377880264074, 5859478.825171477161348 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 828.79998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 826.29998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_559_generated", "manhole_dn": "manhole_560_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387750.394377880264074, 5859478.825171477161348 ], [ 1387786.626276910537854, 5859512.656178202480078 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 851.79998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_560_generated", "manhole_dn": "manhole_561_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387786.626276910537854, 5859512.656178202480078 ], [ 1387822.858175940578803, 5859546.487184926867485 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 851.79998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_561_generated", "manhole_dn": "manhole_562_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387822.858175940578803, 5859546.487184926867485 ], [ 1387850.662340233800933, 5859586.980695966631174 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 891.20001220703125, "invlev_up": 851.79998779296875, "invlev_dn": 888.70001220703125, "manhole_up": "manhole_562_generated", "manhole_dn": "manhole_563_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387850.662340233800933, 5859586.980695966631174 ], [ 1387868.193221996771172, 5859633.330900657922029 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.20001220703125, "elevtn_dn": 876.20001220703125, "invlev_up": 888.70001220703125, "invlev_dn": 873.70001220703125, "manhole_up": "manhole_563_generated", "manhole_dn": "manhole_564_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387868.193221996771172, 5859633.330900657922029 ], [ 1387885.535610173596069, 5859679.769344814121723 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 876.20001220703125, "elevtn_dn": 876.20001220703125, "invlev_up": 873.70001220703125, "invlev_dn": 873.70001220703125, "manhole_up": "manhole_564_generated", "manhole_dn": "manhole_565_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387885.535610173596069, 5859679.769344814121723 ], [ 1387902.854485532967374, 5859726.216552678495646 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 876.20001220703125, "elevtn_dn": 898.29998779296875, "invlev_up": 873.70001220703125, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_565_generated", "manhole_dn": "manhole_566_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387902.854485532967374, 5859726.216552678495646 ], [ 1387920.137465380365029, 5859772.67713953461498 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 898.29998779296875, "invlev_up": 895.79998779296875, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_566_generated", "manhole_dn": "manhole_567_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387920.137465380365029, 5859772.67713953461498 ], [ 1387937.420445227529854, 5859819.137726389802992 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 898.29998779296875, "invlev_up": 895.79998779296875, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_567_generated", "manhole_dn": "manhole_568_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387937.420445227529854, 5859819.137726389802992 ], [ 1387948.863530882401392, 5859867.082766367122531 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 918.5, "invlev_up": 895.79998779296875, "invlev_dn": 916.0, "manhole_up": "manhole_568_generated", "manhole_dn": "manhole_569_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387948.863530882401392, 5859867.082766367122531 ], [ 1387950.013254075078294, 5859916.565449987538159 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 918.5, "invlev_up": 916.0, "invlev_dn": 916.0, "manhole_up": "manhole_569_generated", "manhole_dn": "manhole_570_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387950.013254075078294, 5859916.565449987538159 ], [ 1387947.430782878771424, 5859966.047936389222741 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 918.5, "invlev_up": 916.0, "invlev_dn": 916.0, "manhole_up": "manhole_570_generated", "manhole_dn": "manhole_571_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387947.430782878771424, 5859966.047936389222741 ], [ 1387943.997958281077445, 5860015.499966060742736 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 948.60003662109375, "invlev_up": 916.0, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_571_generated", "manhole_dn": "manhole_572_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387943.997958281077445, 5860015.499966060742736 ], [ 1387940.565133683150634, 5860064.951995733194053 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 948.60003662109375, "invlev_up": 946.10003662109375, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_572_generated", "manhole_dn": "manhole_573_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.565133683150634, 5860064.951995733194053 ], [ 1387945.371777657186612, 5860113.959104515612125 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 948.60003662109375, "invlev_up": 946.10003662109375, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_573_generated", "manhole_dn": "manhole_574_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387945.371777657186612, 5860113.959104515612125 ], [ 1387964.117816498270258, 5860159.736532494425774 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 940.5, "invlev_up": 946.10003662109375, "invlev_dn": 938.0, "manhole_up": "manhole_574_generated", "manhole_dn": "manhole_575_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387964.117816498270258, 5860159.736532494425774 ], [ 1387984.093857799191028, 5860205.104420888237655 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 940.5, "invlev_up": 938.0, "invlev_dn": 938.0, "manhole_up": "manhole_575_generated", "manhole_dn": "manhole_576_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387984.093857799191028, 5860205.104420888237655 ], [ 1388004.069899099878967, 5860250.472309282049537 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 940.5, "invlev_up": 938.0, "invlev_dn": 938.0, "manhole_up": "manhole_576_generated", "manhole_dn": "manhole_577_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388004.069899099878967, 5860250.472309282049537 ], [ 1388027.68692572391592, 5860293.896034284494817 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 971.70001220703125, "invlev_up": 938.0, "invlev_dn": 969.20001220703125, "manhole_up": "manhole_577_generated", "manhole_dn": "manhole_578_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388027.68692572391592, 5860293.896034284494817 ], [ 1388060.096315970877185, 5860331.348726416006684 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 971.70001220703125, "elevtn_dn": 935.5, "invlev_up": 969.20001220703125, "invlev_dn": 933.0, "manhole_up": "manhole_578_generated", "manhole_dn": "manhole_579_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388060.096315970877185, 5860331.348726416006684 ], [ 1388092.967688721138984, 5860368.453448176383972 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 935.5, "invlev_up": 933.0, "invlev_dn": 933.0, "manhole_up": "manhole_579_generated", "manhole_dn": "manhole_580_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388092.967688721138984, 5860368.453448176383972 ], [ 1388119.020827289205045, 5860410.510251956991851 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 949.9000244140625, "invlev_up": 933.0, "invlev_dn": 947.4000244140625, "manhole_up": "manhole_580_generated", "manhole_dn": "manhole_581_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388119.020827289205045, 5860410.510251956991851 ], [ 1388143.407622833969072, 5860453.667774203233421 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 949.9000244140625, "elevtn_dn": 924.60003662109375, "invlev_up": 947.4000244140625, "invlev_dn": 922.10003662109375, "manhole_up": "manhole_581_generated", "manhole_dn": "manhole_582_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388143.407622833969072, 5860453.667774203233421 ], [ 1388167.794418378733099, 5860496.82529644947499 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 924.60003662109375, "elevtn_dn": 924.60003662109375, "invlev_up": 922.10003662109375, "invlev_dn": 922.10003662109375, "manhole_up": "manhole_582_generated", "manhole_dn": "manhole_583_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388167.794418378733099, 5860496.82529644947499 ], [ 1388187.41186453984119, 5860542.097804954275489 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 924.60003662109375, "elevtn_dn": 942.4000244140625, "invlev_up": 922.10003662109375, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_583_generated", "manhole_dn": "manhole_584_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388187.41186453984119, 5860542.097804954275489 ], [ 1388193.385166377527639, 5860591.251542154699564 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 942.4000244140625, "invlev_up": 939.9000244140625, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_584_generated", "manhole_dn": "manhole_585_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388193.385166377527639, 5860591.251542154699564 ], [ 1388198.812296225922182, 5860640.524595490656793 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 942.4000244140625, "invlev_up": 939.9000244140625, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_585_generated", "manhole_dn": "manhole_586_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388198.812296225922182, 5860640.524595490656793 ], [ 1388204.239426074549556, 5860689.7976488256827 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 955.0, "invlev_up": 939.9000244140625, "invlev_dn": 952.5, "manhole_up": "manhole_586_generated", "manhole_dn": "manhole_587_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388204.239426074549556, 5860689.7976488256827 ], [ 1388184.484932377934456, 5860730.700381714850664 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E48", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_587_generated", "manhole_dn": "manhole_588_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388184.484932377934456, 5860730.700381714850664 ], [ 1388159.550175313837826, 5860759.392759991809726 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E49", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_588_generated", "manhole_dn": "manhole_589_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388159.550175313837826, 5860759.392759991809726 ], [ 1388171.988544700434431, 5860807.377908634953201 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E50", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_589_generated", "manhole_dn": "manhole_590_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388171.988544700434431, 5860807.377908634953201 ], [ 1388215.013825689908117, 5860825.214942933060229 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E51", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 941.10003662109375, "invlev_up": 952.5, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_590_generated", "manhole_dn": "manhole_591_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388215.013825689908117, 5860825.214942933060229 ], [ 1388264.397385431453586, 5860829.298032846301794 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E52", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_591_generated", "manhole_dn": "manhole_592_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388264.397385431453586, 5860829.298032846301794 ], [ 1388313.062299854354933, 5860837.304878970608115 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E53", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 937.5, "invlev_up": 938.60003662109375, "invlev_dn": 935.0, "manhole_up": "manhole_592_generated", "manhole_dn": "manhole_593_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388313.062299854354933, 5860837.304878970608115 ], [ 1388360.993895401246846, 5860849.948045967146754 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E54", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.5, "elevtn_dn": 937.5, "invlev_up": 935.0, "invlev_dn": 935.0, "manhole_up": "manhole_593_generated", "manhole_dn": "manhole_594_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388360.993895401246846, 5860849.948045967146754 ], [ 1388408.925490947905928, 5860862.591212964616716 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E55", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.5, "elevtn_dn": 937.60003662109375, "invlev_up": 935.0, "invlev_dn": 935.10003662109375, "manhole_up": "manhole_594_generated", "manhole_dn": "manhole_595_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388408.925490947905928, 5860862.591212964616716 ], [ 1388458.220990223577246, 5860866.957201769575477 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E56", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.60003662109375, "elevtn_dn": 937.60003662109375, "invlev_up": 935.10003662109375, "invlev_dn": 935.10003662109375, "manhole_up": "manhole_595_generated", "manhole_dn": "manhole_596_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388458.220990223577246, 5860866.957201769575477 ], [ 1388507.336333080893382, 5860873.218384950421751 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E57", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.60003662109375, "elevtn_dn": 941.20001220703125, "invlev_up": 935.10003662109375, "invlev_dn": 938.70001220703125, "manhole_up": "manhole_596_generated", "manhole_dn": "manhole_597_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388507.336333080893382, 5860873.218384950421751 ], [ 1388556.215695114107803, 5860881.470384138636291 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E58", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.20001220703125, "elevtn_dn": 941.20001220703125, "invlev_up": 938.70001220703125, "invlev_dn": 938.70001220703125, "manhole_up": "manhole_597_generated", "manhole_dn": "manhole_598_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388556.215695114107803, 5860881.470384138636291 ], [ 1388604.556662159739062, 5860892.361969010904431 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E59", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.20001220703125, "elevtn_dn": 943.10003662109375, "invlev_up": 938.70001220703125, "invlev_dn": 940.60003662109375, "manhole_up": "manhole_598_generated", "manhole_dn": "manhole_599_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388604.556662159739062, 5860892.361969010904431 ], [ 1388653.59940263046883, 5860897.15789801068604 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E60", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 943.10003662109375, "elevtn_dn": 943.10003662109375, "invlev_up": 940.60003662109375, "invlev_dn": 940.60003662109375, "manhole_up": "manhole_599_generated", "manhole_dn": "manhole_600_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388653.59940263046883, 5860897.15789801068604 ], [ 1388700.080393208190799, 5860881.090511013753712 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E61", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 943.10003662109375, "elevtn_dn": 946.10003662109375, "invlev_up": 940.60003662109375, "invlev_dn": 943.60003662109375, "manhole_up": "manhole_600_generated", "manhole_dn": "manhole_601_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388700.080393208190799, 5860881.090511013753712 ], [ 1388732.687003659084439, 5860844.794781206175685 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E62", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 946.10003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 943.60003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_601_generated", "manhole_dn": "manhole_602_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388732.687003659084439, 5860844.794781206175685 ], [ 1388755.953327334951609, 5860801.023035684600472 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E63", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 950.10003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_602_generated", "manhole_dn": "manhole_603_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388755.953327334951609, 5860801.023035684600472 ], [ 1388778.23369869007729, 5860756.84024004638195 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E64", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 950.10003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_603_generated", "manhole_dn": "manhole_604_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388778.23369869007729, 5860756.84024004638195 ], [ 1388792.950793598080054, 5860709.504263866692781 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E65", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 953.79998779296875, "invlev_up": 950.10003662109375, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_604_generated", "manhole_dn": "manhole_605_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388792.950793598080054, 5860709.504263866692781 ], [ 1388807.667888506315649, 5860662.168287687934935 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E66", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_605_generated", "manhole_dn": "manhole_606_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388807.667888506315649, 5860662.168287687934935 ], [ 1388819.224422588944435, 5860613.968191100284457 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E67", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 955.70001220703125, "invlev_up": 951.29998779296875, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_606_generated", "manhole_dn": "manhole_607_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388819.224422588944435, 5860613.968191100284457 ], [ 1388830.63825476472266, 5860565.72907877061516 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E68", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_607_generated", "manhole_dn": "manhole_608_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388830.63825476472266, 5860565.72907877061516 ], [ 1388842.052086940500885, 5860517.489966440014541 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E69", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_608_generated", "manhole_dn": "manhole_609_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388842.052086940500885, 5860517.489966440014541 ], [ 1388862.77624000934884, 5860472.578981296159327 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E70", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 964.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_609_generated", "manhole_dn": "manhole_610_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388862.77624000934884, 5860472.578981296159327 ], [ 1388884.529400010826066, 5860428.03588358964771 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E71", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 951.29998779296875, "invlev_up": 962.20001220703125, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_610_generated", "manhole_dn": "manhole_611_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388884.529400010826066, 5860428.03588358964771 ], [ 1388906.282637836178765, 5860383.492823889479041 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E72", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_611_generated", "manhole_dn": "manhole_612_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388906.282637836178765, 5860383.492823889479041 ], [ 1388933.946375871310011, 5860342.419800435192883 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_32_E73", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_612_generated", "manhole_dn": "manhole_613_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388933.946375871310011, 5860342.419800435192883 ], [ 1388962.240715913940221, 5860301.717001453973353 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_33_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 752.29998779296875, "invlev_up": 759.10003662109375, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_539_generated", "manhole_dn": "manhole_614_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386871.537448140559718, 5859162.609670763835311 ], [ 1386825.19834817154333, 5859175.156894122250378 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_33_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 752.29998779296875, "invlev_up": 749.79998779296875, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_614_generated", "manhole_dn": "manhole_615_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386825.19834817154333, 5859175.156894122250378 ], [ 1386779.333999397465959, 5859189.44842192158103 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_33_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 738.0, "invlev_up": 749.79998779296875, "invlev_dn": 735.5, "manhole_up": "manhole_615_generated", "manhole_dn": "manhole_616_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386779.333999397465959, 5859189.44842192158103 ], [ 1386733.445003136992455, 5859203.660136871039867 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_33_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 738.0, "invlev_up": 735.5, "invlev_dn": 735.5, "manhole_up": "manhole_616_generated", "manhole_dn": "manhole_617_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386733.445003136992455, 5859203.660136871039867 ], [ 1386687.508546756347641, 5859217.718167688697577 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_33_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 763.29998779296875, "invlev_up": 735.5, "invlev_dn": 760.79998779296875, "manhole_up": "manhole_617_generated", "manhole_dn": "manhole_618_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386687.508546756347641, 5859217.718167688697577 ], [ 1386641.572090375469998, 5859231.776198507286608 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_33_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 763.29998779296875, "elevtn_dn": 763.29998779296875, "invlev_up": 760.79998779296875, "invlev_dn": 760.79998779296875, "manhole_up": "manhole_618_generated", "manhole_dn": "manhole_619_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386641.572090375469998, 5859231.776198507286608 ], [ 1386595.451642262749374, 5859245.168246414512396 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_33_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 763.29998779296875, "elevtn_dn": 754.60003662109375, "invlev_up": 760.79998779296875, "invlev_dn": 752.10003662109375, "manhole_up": "manhole_619_generated", "manhole_dn": "manhole_620_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386595.451642262749374, 5859245.168246414512396 ], [ 1386548.813360751140863, 5859256.685926430858672 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_33_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.60003662109375, "elevtn_dn": 754.60003662109375, "invlev_up": 752.10003662109375, "invlev_dn": 752.10003662109375, "manhole_up": "manhole_620_generated", "manhole_dn": "manhole_621_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386548.813360751140863, 5859256.685926430858672 ], [ 1386502.175079239532351, 5859268.203606447204947 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_33_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.60003662109375, "elevtn_dn": 742.5, "invlev_up": 752.10003662109375, "invlev_dn": 740.0, "manhole_up": "manhole_621_generated", "manhole_dn": "manhole_622_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386502.175079239532351, 5859268.203606447204947 ], [ 1386455.354356503346935, 5859278.943273726850748 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_33_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 742.5, "invlev_up": 740.0, "invlev_dn": 740.0, "manhole_up": "manhole_622_generated", "manhole_dn": "manhole_623_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386455.354356503346935, 5859278.943273726850748 ], [ 1386408.879239794565365, 5859290.671229789964855 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_33_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 717.60003662109375, "invlev_up": 740.0, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_623_generated", "manhole_dn": "manhole_624_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386408.879239794565365, 5859290.671229789964855 ], [ 1386364.691368696978316, 5859309.518465746194124 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_33_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 717.60003662109375, "invlev_up": 715.10003662109375, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_624_generated", "manhole_dn": "manhole_625_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386364.691368696978316, 5859309.518465746194124 ], [ 1386320.503497599391267, 5859328.365701701492071 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_33_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 711.0, "invlev_up": 715.10003662109375, "invlev_dn": 708.5, "manhole_up": "manhole_625_generated", "manhole_dn": "manhole_626_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386320.503497599391267, 5859328.365701701492071 ], [ 1386273.173811787506565, 5859335.36546028777957 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 953.70001220703125, "invlev_up": 948.79998779296875, "invlev_dn": 951.20001220703125, "manhole_up": "manhole_10_generated", "manhole_dn": "manhole_627_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388946.301100668497384, 5860414.883977899327874 ], [ 1388922.246059404918924, 5860458.418739438988268 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.70001220703125, "elevtn_dn": 953.70001220703125, "invlev_up": 951.20001220703125, "invlev_dn": 951.20001220703125, "manhole_up": "manhole_627_generated", "manhole_dn": "manhole_628_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388922.246059404918924, 5860458.418739438988268 ], [ 1388900.295977992936969, 5860503.075897979550064 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 951.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_628_generated", "manhole_dn": "manhole_629_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388900.295977992936969, 5860503.075897979550064 ], [ 1388878.345896581187844, 5860547.733056520111859 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 953.79998779296875, "invlev_up": 953.20001220703125, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_629_generated", "manhole_dn": "manhole_630_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388878.345896581187844, 5860547.733056520111859 ], [ 1388856.887740465346724, 5860592.570927501656115 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_630_generated", "manhole_dn": "manhole_631_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388856.887740465346724, 5860592.570927501656115 ], [ 1388853.076019846601412, 5860641.795407227240503 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_631_generated", "manhole_dn": "manhole_632_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388853.076019846601412, 5860641.795407227240503 ], [ 1388856.119826921960339, 5860691.462329030036926 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 952.5, "invlev_up": 951.29998779296875, "invlev_dn": 950.0, "manhole_up": "manhole_632_generated", "manhole_dn": "manhole_633_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388856.119826921960339, 5860691.462329030036926 ], [ 1388859.163633997086436, 5860741.12925083283335 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.5, "elevtn_dn": 952.5, "invlev_up": 950.0, "invlev_dn": 950.0, "manhole_up": "manhole_633_generated", "manhole_dn": "manhole_634_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388859.163633997086436, 5860741.12925083283335 ], [ 1388862.207441072445363, 5860790.796172635629773 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.5, "elevtn_dn": 945.5, "invlev_up": 950.0, "invlev_dn": 943.0, "manhole_up": "manhole_634_generated", "manhole_dn": "manhole_635_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388862.207441072445363, 5860790.796172635629773 ], [ 1388866.356326055014506, 5860840.344227194786072 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 945.5, "invlev_up": 943.0, "invlev_dn": 943.0, "manhole_up": "manhole_635_generated", "manhole_dn": "manhole_636_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388866.356326055014506, 5860840.344227194786072 ], [ 1388873.944740658160299, 5860889.522310186177492 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 945.5, "invlev_up": 943.0, "invlev_dn": 943.0, "manhole_up": "manhole_636_generated", "manhole_dn": "manhole_637_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388873.944740658160299, 5860889.522310186177492 ], [ 1388883.17427325528115, 5860938.398467163555324 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 937.4000244140625, "invlev_up": 943.0, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_637_generated", "manhole_dn": "manhole_638_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388883.17427325528115, 5860938.398467163555324 ], [ 1388890.216840920504183, 5860987.212368851527572 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 937.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_638_generated", "manhole_dn": "manhole_639_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388890.216840920504183, 5860987.212368851527572 ], [ 1388884.322194910608232, 5861036.62209493201226 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 937.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_639_generated", "manhole_dn": "manhole_640_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388884.322194910608232, 5861036.62209493201226 ], [ 1388878.427548900712281, 5861086.031821011565626 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_640_generated", "manhole_dn": "manhole_641_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388878.427548900712281, 5861086.031821011565626 ], [ 1388872.532902890816331, 5861135.441547092050314 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 927.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_641_generated", "manhole_dn": "manhole_642_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388872.532902890816331, 5861135.441547092050314 ], [ 1388866.63825688092038, 5861184.851273172535002 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 927.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_642_generated", "manhole_dn": "manhole_643_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388866.63825688092038, 5861184.851273172535002 ], [ 1388854.620840607210994, 5861232.489912945777178 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 926.60003662109375, "invlev_up": 927.9000244140625, "invlev_dn": 924.10003662109375, "manhole_up": "manhole_643_generated", "manhole_dn": "manhole_644_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388854.620840607210994, 5861232.489912945777178 ], [ 1388833.22756120422855, 5861277.416469449177384 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 926.60003662109375, "elevtn_dn": 926.60003662109375, "invlev_up": 924.10003662109375, "invlev_dn": 924.10003662109375, "manhole_up": "manhole_644_generated", "manhole_dn": "manhole_645_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388833.22756120422855, 5861277.416469449177384 ], [ 1388811.834281801246107, 5861322.343025953508914 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 926.60003662109375, "elevtn_dn": 931.10003662109375, "invlev_up": 924.10003662109375, "invlev_dn": 928.60003662109375, "manhole_up": "manhole_645_generated", "manhole_dn": "manhole_646_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388811.834281801246107, 5861322.343025953508914 ], [ 1388790.441002398030832, 5861367.26958245690912 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 931.10003662109375, "elevtn_dn": 922.20001220703125, "invlev_up": 928.60003662109375, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_646_generated", "manhole_dn": "manhole_647_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388790.441002398030832, 5861367.26958245690912 ], [ 1388769.047722995048389, 5861412.196138960309327 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 922.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_647_generated", "manhole_dn": "manhole_648_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388769.047722995048389, 5861412.196138960309327 ], [ 1388747.654443592065945, 5861457.122695464640856 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 922.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_648_generated", "manhole_dn": "manhole_649_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388747.654443592065945, 5861457.122695464640856 ], [ 1388725.026126575190574, 5861501.410491958260536 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_649_generated", "manhole_dn": "manhole_650_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388725.026126575190574, 5861501.410491958260536 ], [ 1388700.725248141447082, 5861544.833241644315422 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_650_generated", "manhole_dn": "manhole_651_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388700.725248141447082, 5861544.833241644315422 ], [ 1388676.42436970770359, 5861588.255991329438984 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_651_generated", "manhole_dn": "manhole_652_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388676.42436970770359, 5861588.255991329438984 ], [ 1388632.324464634526521, 5861606.441272142343223 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 898.4000244140625, "invlev_up": 897.70001220703125, "invlev_dn": 895.9000244140625, "manhole_up": "manhole_652_generated", "manhole_dn": "manhole_653_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388632.324464634526521, 5861606.441272142343223 ], [ 1388583.463808472501114, 5861611.105615227483213 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.4000244140625, "elevtn_dn": 898.4000244140625, "invlev_up": 895.9000244140625, "invlev_dn": 895.9000244140625, "manhole_up": "manhole_653_generated", "manhole_dn": "manhole_654_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388583.463808472501114, 5861611.105615227483213 ], [ 1388534.764012826373801, 5861604.222017968073487 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.4000244140625, "elevtn_dn": 903.60003662109375, "invlev_up": 895.9000244140625, "invlev_dn": 901.10003662109375, "manhole_up": "manhole_654_generated", "manhole_dn": "manhole_655_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388534.764012826373801, 5861604.222017968073487 ], [ 1388489.566489090910181, 5861583.40731808822602 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 903.60003662109375, "elevtn_dn": 903.60003662109375, "invlev_up": 901.10003662109375, "invlev_dn": 901.10003662109375, "manhole_up": "manhole_655_generated", "manhole_dn": "manhole_656_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388489.566489090910181, 5861583.40731808822602 ], [ 1388444.204915680922568, 5861563.162508152425289 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 903.60003662109375, "elevtn_dn": 906.4000244140625, "invlev_up": 901.10003662109375, "invlev_dn": 903.9000244140625, "manhole_up": "manhole_656_generated", "manhole_dn": "manhole_657_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388444.204915680922568, 5861563.162508152425289 ], [ 1388394.858231473481283, 5861556.761520680040121 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 906.4000244140625, "elevtn_dn": 906.4000244140625, "invlev_up": 903.9000244140625, "invlev_dn": 903.9000244140625, "manhole_up": "manhole_657_generated", "manhole_dn": "manhole_658_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388394.858231473481283, 5861556.761520680040121 ], [ 1388350.680838279658929, 5861570.408674017526209 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 906.4000244140625, "elevtn_dn": 900.20001220703125, "invlev_up": 903.9000244140625, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_658_generated", "manhole_dn": "manhole_659_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388350.680838279658929, 5861570.408674017526209 ], [ 1388310.581732882419601, 5861599.872713611461222 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_659_generated", "manhole_dn": "manhole_660_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388310.581732882419601, 5861599.872713611461222 ], [ 1388271.039625711739063, 5861629.969603477045894 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 890.0, "invlev_up": 897.70001220703125, "invlev_dn": 887.5, "manhole_up": "manhole_660_generated", "manhole_dn": "manhole_661_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388271.039625711739063, 5861629.969603477045894 ], [ 1388236.722210306907073, 5861666.002683873288333 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 890.0, "invlev_up": 887.5, "invlev_dn": 887.5, "manhole_up": "manhole_661_generated", "manhole_dn": "manhole_662_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388236.722210306907073, 5861666.002683873288333 ], [ 1388202.404794902307913, 5861702.035764269530773 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 890.0, "invlev_up": 887.5, "invlev_dn": 887.5, "manhole_up": "manhole_662_generated", "manhole_dn": "manhole_663_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388202.404794902307913, 5861702.035764269530773 ], [ 1388168.087379497475922, 5861738.068844665773213 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 885.9000244140625, "invlev_up": 887.5, "invlev_dn": 883.4000244140625, "manhole_up": "manhole_663_generated", "manhole_dn": "manhole_664_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388168.087379497475922, 5861738.068844665773213 ], [ 1388133.769964092643932, 5861774.101925062015653 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 885.9000244140625, "elevtn_dn": 874.0, "invlev_up": 883.4000244140625, "invlev_dn": 871.5, "manhole_up": "manhole_664_generated", "manhole_dn": "manhole_665_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388133.769964092643932, 5861774.101925062015653 ], [ 1388099.452548687811941, 5861810.13500545732677 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 874.0, "elevtn_dn": 874.0, "invlev_up": 871.5, "invlev_dn": 871.5, "manhole_up": "manhole_665_generated", "manhole_dn": "manhole_666_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388099.452548687811941, 5861810.13500545732677 ], [ 1388065.135133283212781, 5861846.16808585356921 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 874.0, "elevtn_dn": 862.20001220703125, "invlev_up": 871.5, "invlev_dn": 859.70001220703125, "manhole_up": "manhole_666_generated", "manhole_dn": "manhole_667_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388065.135133283212781, 5861846.16808585356921 ], [ 1388022.995196633273736, 5861866.899685021489859 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 862.20001220703125, "elevtn_dn": 862.20001220703125, "invlev_up": 859.70001220703125, "invlev_dn": 859.70001220703125, "manhole_up": "manhole_667_generated", "manhole_dn": "manhole_668_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388022.995196633273736, 5861866.899685021489859 ], [ 1387973.690499771386385, 5861873.616436487063766 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 862.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 859.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_668_generated", "manhole_dn": "manhole_669_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387973.690499771386385, 5861873.616436487063766 ], [ 1387924.470484273741022, 5861880.90659652557224 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_669_generated", "manhole_dn": "manhole_670_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387924.470484273741022, 5861880.90659652557224 ], [ 1387877.962616891367361, 5861896.157046243548393 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_670_generated", "manhole_dn": "manhole_671_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387877.962616891367361, 5861896.157046243548393 ], [ 1387917.070526217576116, 5861911.915829903446138 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_671_generated", "manhole_dn": "manhole_672_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387917.070526217576116, 5861911.915829903446138 ], [ 1387966.654667611001059, 5861916.096835186704993 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 846.29998779296875, "invlev_up": 856.70001220703125, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_672_generated", "manhole_dn": "manhole_673_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387966.654667611001059, 5861916.096835186704993 ], [ 1388016.318005530629307, 5861919.063731476664543 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 850.10003662109375, "invlev_up": 843.79998779296875, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_673_generated", "manhole_dn": "manhole_674_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388016.318005530629307, 5861919.063731476664543 ], [ 1388066.025120510486886, 5861921.359510923735797 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E48", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 850.10003662109375, "invlev_up": 847.60003662109375, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_674_generated", "manhole_dn": "manhole_675_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388066.025120510486886, 5861921.359510923735797 ], [ 1388115.732235490344465, 5861923.655290370807052 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E49", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 849.0, "invlev_up": 847.60003662109375, "invlev_dn": 846.5, "manhole_up": "manhole_675_generated", "manhole_dn": "manhole_676_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388115.732235490344465, 5861923.655290370807052 ], [ 1388161.130695321131498, 5861931.457672152668238 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E50", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 849.0, "elevtn_dn": 850.10003662109375, "invlev_up": 846.5, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_676_generated", "manhole_dn": "manhole_677_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388161.130695321131498, 5861931.457672152668238 ], [ 1388139.871223766123876, 5861964.082641129381955 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E51", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 850.10003662109375, "invlev_up": 847.60003662109375, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_677_generated", "manhole_dn": "manhole_678_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388139.871223766123876, 5861964.082641129381955 ], [ 1388090.726845995755866, 5861957.769498392008245 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E52", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 846.29998779296875, "invlev_up": 847.60003662109375, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_678_generated", "manhole_dn": "manhole_679_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388090.726845995755866, 5861957.769498392008245 ], [ 1388049.339104855433106, 5861983.736727176234126 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E53", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 846.29998779296875, "invlev_up": 843.79998779296875, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_679_generated", "manhole_dn": "manhole_680_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388049.339104855433106, 5861983.736727176234126 ], [ 1388024.713075590552762, 5862026.975905770435929 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E54", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 846.29998779296875, "invlev_up": 843.79998779296875, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_680_generated", "manhole_dn": "manhole_681_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388024.713075590552762, 5862026.975905770435929 ], [ 1387980.016218039905652, 5862047.702198376879096 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E55", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 793.5, "invlev_up": 843.79998779296875, "invlev_dn": 791.0, "manhole_up": "manhole_681_generated", "manhole_dn": "manhole_682_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387980.016218039905652, 5862047.702198376879096 ], [ 1387931.90673128189519, 5862056.853296543471515 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E56", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.5, "elevtn_dn": 793.5, "invlev_up": 791.0, "invlev_dn": 791.0, "manhole_up": "manhole_682_generated", "manhole_dn": "manhole_683_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387931.90673128189519, 5862056.853296543471515 ], [ 1387882.187313467729837, 5862058.865105460397899 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E57", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.5, "elevtn_dn": 793.20001220703125, "invlev_up": 791.0, "invlev_dn": 790.70001220703125, "manhole_up": "manhole_683_generated", "manhole_dn": "manhole_684_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387882.187313467729837, 5862058.865105460397899 ], [ 1387832.722497318405658, 5862057.3410848621279 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E58", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.20001220703125, "elevtn_dn": 830.29998779296875, "invlev_up": 790.70001220703125, "invlev_dn": 827.79998779296875, "manhole_up": "manhole_684_generated", "manhole_dn": "manhole_685_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387832.722497318405658, 5862057.3410848621279 ], [ 1387783.80423084856011, 5862048.226750630885363 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E59", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.29998779296875, "elevtn_dn": 817.70001220703125, "invlev_up": 827.79998779296875, "invlev_dn": 815.20001220703125, "manhole_up": "manhole_685_generated", "manhole_dn": "manhole_686_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387783.80423084856011, 5862048.226750630885363 ], [ 1387734.885964378714561, 5862039.112416399642825 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E60", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 817.70001220703125, "elevtn_dn": 813.70001220703125, "invlev_up": 815.20001220703125, "invlev_dn": 811.20001220703125, "manhole_up": "manhole_686_generated", "manhole_dn": "manhole_687_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387734.885964378714561, 5862039.112416399642825 ], [ 1387685.967697908869013, 5862029.998082168400288 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E61", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 813.70001220703125, "elevtn_dn": 813.70001220703125, "invlev_up": 811.20001220703125, "invlev_dn": 811.20001220703125, "manhole_up": "manhole_687_generated", "manhole_dn": "manhole_688_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387685.967697908869013, 5862029.998082168400288 ], [ 1387637.036115845199674, 5862020.957140567712486 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E62", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 813.70001220703125, "elevtn_dn": 807.0, "invlev_up": 811.20001220703125, "invlev_dn": 804.5, "manhole_up": "manhole_688_generated", "manhole_dn": "manhole_689_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387637.036115845199674, 5862020.957140567712486 ], [ 1387588.033849656581879, 5862012.305794355459511 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E63", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.0, "elevtn_dn": 807.0, "invlev_up": 804.5, "invlev_dn": 804.5, "manhole_up": "manhole_689_generated", "manhole_dn": "manhole_690_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387588.033849656581879, 5862012.305794355459511 ], [ 1387539.031583468196914, 5862003.654448143206537 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E64", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.0, "elevtn_dn": 793.10003662109375, "invlev_up": 804.5, "invlev_dn": 790.60003662109375, "manhole_up": "manhole_690_generated", "manhole_dn": "manhole_691_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387539.031583468196914, 5862003.654448143206537 ], [ 1387490.029317279579118, 5861995.003101930953562 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E65", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.10003662109375, "elevtn_dn": 793.10003662109375, "invlev_up": 790.60003662109375, "invlev_dn": 790.60003662109375, "manhole_up": "manhole_691_generated", "manhole_dn": "manhole_692_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387490.029317279579118, 5861995.003101930953562 ], [ 1387440.720367865404114, 5861989.908138634636998 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E66", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.10003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 790.60003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_692_generated", "manhole_dn": "manhole_693_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387440.720367865404114, 5861989.908138634636998 ], [ 1387390.960446665296331, 5861990.042768024839461 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E67", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_693_generated", "manhole_dn": "manhole_694_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387390.960446665296331, 5861990.042768024839461 ], [ 1387341.200525465421379, 5861990.177397414110601 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E68", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 749.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 747.10003662109375, "manhole_up": "manhole_694_generated", "manhole_dn": "manhole_695_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387341.200525465421379, 5861990.177397414110601 ], [ 1387291.440604265546426, 5861990.312026804313064 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E69", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 749.60003662109375, "elevtn_dn": 749.60003662109375, "invlev_up": 747.10003662109375, "invlev_dn": 747.10003662109375, "manhole_up": "manhole_695_generated", "manhole_dn": "manhole_696_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387291.440604265546426, 5861990.312026804313064 ], [ 1387246.706285298336297, 5861974.212805554270744 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E70", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 749.60003662109375, "elevtn_dn": 747.0, "invlev_up": 747.10003662109375, "invlev_dn": 744.5, "manhole_up": "manhole_696_generated", "manhole_dn": "manhole_697_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387246.706285298336297, 5861974.212805554270744 ], [ 1387205.725988702848554, 5861945.987228964455426 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E71", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.0, "elevtn_dn": 771.79998779296875, "invlev_up": 744.5, "invlev_dn": 769.29998779296875, "manhole_up": "manhole_697_generated", "manhole_dn": "manhole_698_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387205.725988702848554, 5861945.987228964455426 ], [ 1387164.745692107127979, 5861917.761652374640107 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E72", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.79998779296875, "elevtn_dn": 764.10003662109375, "invlev_up": 769.29998779296875, "invlev_dn": 761.60003662109375, "manhole_up": "manhole_698_generated", "manhole_dn": "manhole_699_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387164.745692107127979, 5861917.761652374640107 ], [ 1387115.569933785125613, 5861911.215812381356955 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E73", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.10003662109375, "elevtn_dn": 764.10003662109375, "invlev_up": 761.60003662109375, "invlev_dn": 761.60003662109375, "manhole_up": "manhole_699_generated", "manhole_dn": "manhole_700_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387115.569933785125613, 5861911.215812381356955 ], [ 1387066.165866439929232, 5861905.273926095105708 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E74", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.10003662109375, "elevtn_dn": 747.70001220703125, "invlev_up": 761.60003662109375, "invlev_dn": 745.20001220703125, "manhole_up": "manhole_700_generated", "manhole_dn": "manhole_701_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387066.165866439929232, 5861905.273926095105708 ], [ 1387016.666836149292067, 5861900.238133460283279 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E75", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.70001220703125, "elevtn_dn": 747.70001220703125, "invlev_up": 745.20001220703125, "invlev_dn": 745.20001220703125, "manhole_up": "manhole_701_generated", "manhole_dn": "manhole_702_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387016.666836149292067, 5861900.238133460283279 ], [ 1386975.698310127714649, 5861874.842493440955877 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E76", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.70001220703125, "elevtn_dn": 739.60003662109375, "invlev_up": 745.20001220703125, "invlev_dn": 737.10003662109375, "manhole_up": "manhole_702_generated", "manhole_dn": "manhole_703_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386975.698310127714649, 5861874.842493440955877 ], [ 1386937.286019780673087, 5861843.21080310922116 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E77", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.60003662109375, "elevtn_dn": 739.60003662109375, "invlev_up": 737.10003662109375, "invlev_dn": 737.10003662109375, "manhole_up": "manhole_703_generated", "manhole_dn": "manhole_704_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386937.286019780673087, 5861843.21080310922116 ], [ 1386898.873729433864355, 5861811.579112778417766 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E78", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.60003662109375, "elevtn_dn": 755.20001220703125, "invlev_up": 737.10003662109375, "invlev_dn": 752.70001220703125, "manhole_up": "manhole_704_generated", "manhole_dn": "manhole_705_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386898.873729433864355, 5861811.579112778417766 ], [ 1386860.461439087055624, 5861779.947422447614372 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E79", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.20001220703125, "elevtn_dn": 745.29998779296875, "invlev_up": 752.70001220703125, "invlev_dn": 742.79998779296875, "manhole_up": "manhole_705_generated", "manhole_dn": "manhole_706_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386860.461439087055624, 5861779.947422447614372 ], [ 1386822.049148740014061, 5861748.315732115879655 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E80", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 745.29998779296875, "elevtn_dn": 745.29998779296875, "invlev_up": 742.79998779296875, "invlev_dn": 742.79998779296875, "manhole_up": "manhole_706_generated", "manhole_dn": "manhole_707_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386822.049148740014061, 5861748.315732115879655 ], [ 1386774.418702265014872, 5861733.958941764198244 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E81", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 745.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 742.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_707_generated", "manhole_dn": "manhole_708_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386774.418702265014872, 5861733.958941764198244 ], [ 1386726.75721522886306, 5861719.660321676172316 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E82", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_708_generated", "manhole_dn": "manhole_709_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386726.75721522886306, 5861719.660321676172316 ], [ 1386681.211287560872734, 5861700.510515534318984 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E83", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 777.9000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_709_generated", "manhole_dn": "manhole_710_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386681.211287560872734, 5861700.510515534318984 ], [ 1386655.081909105414525, 5861659.807657876051962 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E84", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 758.79998779296875, "invlev_up": 775.4000244140625, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_710_generated", "manhole_dn": "manhole_711_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386655.081909105414525, 5861659.807657876051962 ], [ 1386647.41175345890224, 5861610.757949161343277 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E85", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_711_generated", "manhole_dn": "manhole_712_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386647.41175345890224, 5861610.757949161343277 ], [ 1386641.745189253240824, 5861561.363539570011199 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E86", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 732.4000244140625, "invlev_up": 756.29998779296875, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_712_generated", "manhole_dn": "manhole_713_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386641.745189253240824, 5861561.363539570011199 ], [ 1386642.37134926696308, 5861511.607376066967845 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E87", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_713_generated", "manhole_dn": "manhole_714_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386642.37134926696308, 5861511.607376066967845 ], [ 1386642.997509280918166, 5861461.851212563924491 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E88", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_714_generated", "manhole_dn": "manhole_715_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386642.997509280918166, 5861461.851212563924491 ], [ 1386643.623669294640422, 5861412.09504906181246 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_34_E89", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 724.29998779296875, "invlev_up": 729.9000244140625, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_715_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386643.623669294640422, 5861412.09504906181246 ], [ 1386648.271799877518788, 5861347.644815167412162 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_35_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_35", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_35", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_716_generated", "manhole_dn": "manhole_717_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386060.978602184914052, 5859873.390328846871853 ], [ 1386078.54455375042744, 5859857.065600479952991 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_35_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_35", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_35", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_717_generated", "manhole_dn": "manhole_718_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386078.54455375042744, 5859857.065600479952991 ], [ 1386079.86695942771621, 5859885.500408614054322 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_36_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_36", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_36", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_719_generated", "manhole_dn": "manhole_716_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386030.926458492642269, 5859869.881591100245714 ], [ 1386060.978602184914052, 5859873.390328846871853 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_37_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_37", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_37", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_720_generated", "manhole_dn": "manhole_716_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386043.381105761509389, 5859908.11929196305573 ], [ 1386060.978602184914052, 5859873.390328846871853 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_38_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_38", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_718_generated", "manhole_dn": "manhole_721_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386079.86695942771621, 5859885.500408614054322 ], [ 1386081.40363402524963, 5859934.756705570034683 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_38_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_38", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_721_generated", "manhole_dn": "manhole_722_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386081.40363402524963, 5859934.756705570034683 ], [ 1386080.471781946951523, 5859983.948014200665057 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_38_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_38", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 756.5, "invlev_up": 763.79998779296875, "invlev_dn": 754.0, "manhole_up": "manhole_722_generated", "manhole_dn": "manhole_723_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386080.471781946951523, 5859983.948014200665057 ], [ 1386081.101269942475483, 5860033.01989212166518 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_39_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_39", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_718_generated", "manhole_dn": "manhole_724_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386079.86695942771621, 5859885.500408614054322 ], [ 1386051.415038994979113, 5859913.714703594334424 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_39_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_39", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_724_generated", "manhole_dn": "manhole_725_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386051.415038994979113, 5859913.714703594334424 ], [ 1386056.753747603856027, 5859949.43277302198112 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_39_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_39", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_725_generated", "manhole_dn": "manhole_726_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386056.753747603856027, 5859949.43277302198112 ], [ 1386070.153564189793542, 5859990.873222404159606 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_39_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_39", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 756.5, "invlev_up": 763.79998779296875, "invlev_dn": 754.0, "manhole_up": "manhole_726_generated", "manhole_dn": "manhole_723_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386070.153564189793542, 5859990.873222404159606 ], [ 1386081.101269942475483, 5860033.01989212166518 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.5, "elevtn_dn": 756.5, "invlev_up": 754.0, "invlev_dn": 754.0, "manhole_up": "manhole_723_generated", "manhole_dn": "manhole_727_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386081.101269942475483, 5860033.01989212166518 ], [ 1386095.159510504920036, 5860079.476792480796576 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.5, "elevtn_dn": 720.29998779296875, "invlev_up": 754.0, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_727_generated", "manhole_dn": "manhole_728_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386095.159510504920036, 5860079.476792480796576 ], [ 1386119.249574675457552, 5860122.285581497475505 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_728_generated", "manhole_dn": "manhole_729_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386119.249574675457552, 5860122.285581497475505 ], [ 1386143.813145637512207, 5860164.822058788500726 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 732.5, "invlev_up": 717.79998779296875, "invlev_dn": 730.0, "manhole_up": "manhole_729_generated", "manhole_dn": "manhole_730_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386143.813145637512207, 5860164.822058788500726 ], [ 1386168.698389830067754, 5860207.173543182201684 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.5, "elevtn_dn": 732.5, "invlev_up": 730.0, "invlev_dn": 730.0, "manhole_up": "manhole_730_generated", "manhole_dn": "manhole_731_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386168.698389830067754, 5860207.173543182201684 ], [ 1386190.960878706537187, 5860250.914158629253507 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.5, "elevtn_dn": 720.29998779296875, "invlev_up": 730.0, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_731_generated", "manhole_dn": "manhole_732_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386190.960878706537187, 5860250.914158629253507 ], [ 1386212.013376480899751, 5860295.295640649273992 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 729.10003662109375, "invlev_up": 717.79998779296875, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_732_generated", "manhole_dn": "manhole_733_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386212.013376480899751, 5860295.295640649273992 ], [ 1386233.065874255495146, 5860339.677122670225799 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 729.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_733_generated", "manhole_dn": "manhole_734_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386233.065874255495146, 5860339.677122670225799 ], [ 1386254.118372030090541, 5860384.058604690246284 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 729.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_734_generated", "manhole_dn": "manhole_735_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386254.118372030090541, 5860384.058604690246284 ], [ 1386270.265550139825791, 5860430.368606903590262 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 746.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 743.60003662109375, "manhole_up": "manhole_735_generated", "manhole_dn": "manhole_736_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386270.265550139825791, 5860430.368606903590262 ], [ 1386284.690116602927446, 5860477.310510716401041 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 746.10003662109375, "elevtn_dn": 746.10003662109375, "invlev_up": 743.60003662109375, "invlev_dn": 743.60003662109375, "manhole_up": "manhole_736_generated", "manhole_dn": "manhole_737_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386284.690116602927446, 5860477.310510716401041 ], [ 1386295.943752367515117, 5860525.125563691370189 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 746.10003662109375, "elevtn_dn": 720.29998779296875, "invlev_up": 743.60003662109375, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_737_generated", "manhole_dn": "manhole_738_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386295.943752367515117, 5860525.125563691370189 ], [ 1386307.197388132335618, 5860572.940616665408015 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_738_generated", "manhole_dn": "manhole_739_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386307.197388132335618, 5860572.940616665408015 ], [ 1386318.451023896923289, 5860620.755669640377164 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_739_generated", "manhole_dn": "manhole_740_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386318.451023896923289, 5860620.755669640377164 ], [ 1386329.704659661510959, 5860668.57072261441499 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 737.60003662109375, "invlev_up": 717.79998779296875, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_740_generated", "manhole_dn": "manhole_741_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386329.704659661510959, 5860668.57072261441499 ], [ 1386340.95829542633146, 5860716.385775589384139 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 737.60003662109375, "invlev_up": 735.10003662109375, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_741_generated", "manhole_dn": "manhole_742_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386340.95829542633146, 5860716.385775589384139 ], [ 1386352.211931190919131, 5860764.200828563421965 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 737.60003662109375, "invlev_up": 735.10003662109375, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_742_generated", "manhole_dn": "manhole_743_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386352.211931190919131, 5860764.200828563421965 ], [ 1386365.771370212780312, 5860811.365820310078561 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 744.5, "invlev_up": 735.10003662109375, "invlev_dn": 742.0, "manhole_up": "manhole_743_generated", "manhole_dn": "manhole_744_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386365.771370212780312, 5860811.365820310078561 ], [ 1386381.150273493025452, 5860858.017861452884972 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 744.5, "elevtn_dn": 724.29998779296875, "invlev_up": 742.0, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_744_generated", "manhole_dn": "manhole_745_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386381.150273493025452, 5860858.017861452884972 ], [ 1386398.399082327727228, 5860903.951519219204783 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_745_generated", "manhole_dn": "manhole_746_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386398.399082327727228, 5860903.951519219204783 ], [ 1386418.211523674428463, 5860948.90027645137161 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_746_generated", "manhole_dn": "manhole_747_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386418.211523674428463, 5860948.90027645137161 ], [ 1386441.67837643600069, 5860992.033180211670697 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_747_generated", "manhole_dn": "manhole_748_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386441.67837643600069, 5860992.033180211670697 ], [ 1386465.536530936835334, 5861034.971648660488427 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.9000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 722.4000244140625, "manhole_up": "manhole_748_generated", "manhole_dn": "manhole_749_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386465.536530936835334, 5861034.971648660488427 ], [ 1386489.394685437437147, 5861077.910117109306157 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.9000244140625, "elevtn_dn": 724.29998779296875, "invlev_up": 722.4000244140625, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_749_generated", "manhole_dn": "manhole_750_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386489.394685437437147, 5861077.910117109306157 ], [ 1386513.252839938271791, 5861120.848585557192564 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_750_generated", "manhole_dn": "manhole_751_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386513.252839938271791, 5861120.848585557192564 ], [ 1386537.110994438873604, 5861163.787054006010294 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_751_generated", "manhole_dn": "manhole_752_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386537.110994438873604, 5861163.787054006010294 ], [ 1386560.969148939708248, 5861206.725522454828024 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_752_generated", "manhole_dn": "manhole_753_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386560.969148939708248, 5861206.725522454828024 ], [ 1386584.827303440310061, 5861249.663990902714431 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_753_generated", "manhole_dn": "manhole_754_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386584.827303440310061, 5861249.663990902714431 ], [ 1386607.696082097478211, 5861293.105181481689215 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_754_generated", "manhole_dn": "manhole_755_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386607.696082097478211, 5861293.105181481689215 ], [ 1386626.999141034670174, 5861338.164890616200864 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 732.4000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_755_generated", "manhole_dn": "manhole_756_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386626.999141034670174, 5861338.164890616200864 ], [ 1386632.635544582502916, 5861386.242180755361915 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_756_generated", "manhole_dn": "manhole_757_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386632.635544582502916, 5861386.242180755361915 ], [ 1386628.332881111185998, 5861435.174896763637662 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_757_generated", "manhole_dn": "manhole_758_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386628.332881111185998, 5861435.174896763637662 ], [ 1386624.030217639869079, 5861484.107612771913409 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 758.79998779296875, "invlev_up": 729.9000244140625, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_758_generated", "manhole_dn": "manhole_759_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386624.030217639869079, 5861484.107612771913409 ], [ 1386619.72755416855216, 5861533.040328779257834 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_759_generated", "manhole_dn": "manhole_760_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386619.72755416855216, 5861533.040328779257834 ], [ 1386620.396809899713844, 5861581.843449912965298 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_760_generated", "manhole_dn": "manhole_761_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386620.396809899713844, 5861581.843449912965298 ], [ 1386627.242796876933426, 5861630.485572309233248 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 777.9000244140625, "invlev_up": 756.29998779296875, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_761_generated", "manhole_dn": "manhole_762_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386627.242796876933426, 5861630.485572309233248 ], [ 1386633.497009602142498, 5861679.177458625286818 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 777.9000244140625, "invlev_up": 775.4000244140625, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_762_generated", "manhole_dn": "manhole_763_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386633.497009602142498, 5861679.177458625286818 ], [ 1386633.587326586712152, 5861728.232037586160004 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 777.9000244140625, "invlev_up": 775.4000244140625, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_763_generated", "manhole_dn": "manhole_764_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386633.587326586712152, 5861728.232037586160004 ], [ 1386628.569951781770214, 5861777.096641942858696 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_40_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 787.0, "invlev_up": 775.4000244140625, "invlev_dn": 784.5, "manhole_up": "manhole_764_generated", "manhole_dn": "manhole_765_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386628.569951781770214, 5861777.096641942858696 ], [ 1386623.552576976828277, 5861825.961246299557388 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.0, "elevtn_dn": 787.0, "invlev_up": 784.5, "invlev_dn": 784.5, "manhole_up": "manhole_765_generated", "manhole_dn": "manhole_766_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386623.552576976828277, 5861825.961246299557388 ], [ 1386622.452884682221338, 5861875.377415779046714 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.0, "elevtn_dn": 768.0, "invlev_up": 784.5, "invlev_dn": 765.5, "manhole_up": "manhole_766_generated", "manhole_dn": "manhole_767_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386622.452884682221338, 5861875.377415779046714 ], [ 1386630.050831846194342, 5861924.208797036670148 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_767_generated", "manhole_dn": "manhole_768_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386630.050831846194342, 5861924.208797036670148 ], [ 1386645.112437101313844, 5861971.295391816645861 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_768_generated", "manhole_dn": "manhole_769_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386645.112437101313844, 5861971.295391816645861 ], [ 1386663.826805545249954, 5862017.116109635680914 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 729.0, "invlev_up": 765.5, "invlev_dn": 726.5, "manhole_up": "manhole_769_generated", "manhole_dn": "manhole_770_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386663.826805545249954, 5862017.116109635680914 ], [ 1386682.541173989186063, 5862062.93682745564729 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 729.0, "invlev_up": 726.5, "invlev_dn": 726.5, "manhole_up": "manhole_770_generated", "manhole_dn": "manhole_771_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386682.541173989186063, 5862062.93682745564729 ], [ 1386700.357504795538262, 5862109.113540357910097 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 729.0, "invlev_up": 726.5, "invlev_dn": 726.5, "manhole_up": "manhole_771_generated", "manhole_dn": "manhole_772_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386700.357504795538262, 5862109.113540357910097 ], [ 1386718.120609947945923, 5862155.311352676711977 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 724.29998779296875, "invlev_up": 726.5, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_772_generated", "manhole_dn": "manhole_773_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386718.120609947945923, 5862155.311352676711977 ], [ 1386735.883715100120753, 5862201.509164996445179 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_773_generated", "manhole_dn": "manhole_774_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386735.883715100120753, 5862201.509164996445179 ], [ 1386757.522535112220794, 5862245.993861058726907 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_774_generated", "manhole_dn": "manhole_775_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386757.522535112220794, 5862245.993861058726907 ], [ 1386779.73098383564502, 5862290.226773838512599 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_775_generated", "manhole_dn": "manhole_776_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386779.73098383564502, 5862290.226773838512599 ], [ 1386802.545179207576439, 5862334.095372994430363 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_776_generated", "manhole_dn": "manhole_777_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386802.545179207576439, 5862334.095372994430363 ], [ 1386831.207993831252679, 5862374.446442689746618 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 737.70001220703125, "invlev_up": 721.79998779296875, "invlev_dn": 735.20001220703125, "manhole_up": "manhole_777_generated", "manhole_dn": "manhole_778_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386831.207993831252679, 5862374.446442689746618 ], [ 1386859.988485741894692, 5862414.708453865721822 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.70001220703125, "elevtn_dn": 737.70001220703125, "invlev_up": 735.20001220703125, "invlev_dn": 735.20001220703125, "manhole_up": "manhole_778_generated", "manhole_dn": "manhole_779_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386859.988485741894692, 5862414.708453865721822 ], [ 1386891.035651177866384, 5862453.255039785988629 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.70001220703125, "elevtn_dn": 743.9000244140625, "invlev_up": 735.20001220703125, "invlev_dn": 741.4000244140625, "manhole_up": "manhole_779_generated", "manhole_dn": "manhole_780_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386891.035651177866384, 5862453.255039785988629 ], [ 1386922.082816614070907, 5862491.801625707186759 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 743.9000244140625, "elevtn_dn": 756.0, "invlev_up": 741.4000244140625, "invlev_dn": 753.5, "manhole_up": "manhole_780_generated", "manhole_dn": "manhole_781_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386922.082816614070907, 5862491.801625707186759 ], [ 1386953.12998205027543, 5862530.348211627453566 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.0, "elevtn_dn": 756.0, "invlev_up": 753.5, "invlev_dn": 753.5, "manhole_up": "manhole_781_generated", "manhole_dn": "manhole_782_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386953.12998205027543, 5862530.348211627453566 ], [ 1386984.177147486479953, 5862568.894797547720373 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.0, "elevtn_dn": 761.4000244140625, "invlev_up": 753.5, "invlev_dn": 758.9000244140625, "manhole_up": "manhole_782_generated", "manhole_dn": "manhole_783_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386984.177147486479953, 5862568.894797547720373 ], [ 1387010.83190148579888, 5862610.297833287157118 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.4000244140625, "elevtn_dn": 761.4000244140625, "invlev_up": 758.9000244140625, "invlev_dn": 758.9000244140625, "manhole_up": "manhole_783_generated", "manhole_dn": "manhole_784_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387010.83190148579888, 5862610.297833287157118 ], [ 1387033.474099110113457, 5862654.310293504968286 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.4000244140625, "elevtn_dn": 770.5, "invlev_up": 758.9000244140625, "invlev_dn": 768.0, "manhole_up": "manhole_784_generated", "manhole_dn": "manhole_785_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387033.474099110113457, 5862654.310293504968286 ], [ 1387056.116296734428033, 5862698.322753723710775 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.5, "elevtn_dn": 765.29998779296875, "invlev_up": 768.0, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_785_generated", "manhole_dn": "manhole_786_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387056.116296734428033, 5862698.322753723710775 ], [ 1387078.75849435874261, 5862742.335213942453265 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 765.29998779296875, "invlev_up": 762.79998779296875, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_786_generated", "manhole_dn": "manhole_787_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387078.75849435874261, 5862742.335213942453265 ], [ 1387101.400691983057186, 5862786.347674161195755 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 765.29998779296875, "invlev_up": 762.79998779296875, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_787_generated", "manhole_dn": "manhole_788_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387101.400691983057186, 5862786.347674161195755 ], [ 1387124.783531384309754, 5862829.966971693560481 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 764.20001220703125, "invlev_up": 762.79998779296875, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_788_generated", "manhole_dn": "manhole_789_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387124.783531384309754, 5862829.966971693560481 ], [ 1387148.551342260092497, 5862873.381910757161677 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 764.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_789_generated", "manhole_dn": "manhole_790_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387148.551342260092497, 5862873.381910757161677 ], [ 1387176.029596295906231, 5862914.516764627769589 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 764.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_790_generated", "manhole_dn": "manhole_791_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387176.029596295906231, 5862914.516764627769589 ], [ 1387204.050833505578339, 5862955.315435893833637 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 769.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 766.70001220703125, "manhole_up": "manhole_791_generated", "manhole_dn": "manhole_792_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387204.050833505578339, 5862955.315435893833637 ], [ 1387233.152246462181211, 5862995.351338926702738 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.20001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 766.70001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_792_generated", "manhole_dn": "manhole_793_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387233.152246462181211, 5862995.351338926702738 ], [ 1387262.253659419016913, 5863035.387241959571838 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 770.20001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_793_generated", "manhole_dn": "manhole_794_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387262.253659419016913, 5863035.387241959571838 ], [ 1387289.177211825968698, 5863076.714860137552023 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 770.20001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_794_generated", "manhole_dn": "manhole_795_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387289.177211825968698, 5863076.714860137552023 ], [ 1387304.666786204557866, 5863123.392671256326139 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 762.0, "invlev_up": 770.20001220703125, "invlev_dn": 759.5, "manhole_up": "manhole_795_generated", "manhole_dn": "manhole_796_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387304.666786204557866, 5863123.392671256326139 ], [ 1387314.520281337434426, 5863171.895173518918455 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 777.10003662109375, "invlev_up": 759.5, "invlev_dn": 774.60003662109375, "manhole_up": "manhole_796_generated", "manhole_dn": "manhole_797_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387314.520281337434426, 5863171.895173518918455 ], [ 1387324.142220750683919, 5863220.446013364940882 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.10003662109375, "elevtn_dn": 780.4000244140625, "invlev_up": 774.60003662109375, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_797_generated", "manhole_dn": "manhole_798_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387324.142220750683919, 5863220.446013364940882 ], [ 1387333.764160163700581, 5863268.996853210031986 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 780.4000244140625, "invlev_up": 777.9000244140625, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_798_generated", "manhole_dn": "manhole_799_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387333.764160163700581, 5863268.996853210031986 ], [ 1387343.386099576717243, 5863317.547693055123091 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 780.4000244140625, "invlev_up": 777.9000244140625, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_799_generated", "manhole_dn": "manhole_800_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387343.386099576717243, 5863317.547693055123091 ], [ 1387353.008038989733905, 5863366.098532900214195 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 762.0, "invlev_up": 777.9000244140625, "invlev_dn": 759.5, "manhole_up": "manhole_800_generated", "manhole_dn": "manhole_801_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387353.008038989733905, 5863366.098532900214195 ], [ 1387364.066297837067395, 5863414.311534740030766 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_801_generated", "manhole_dn": "manhole_802_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387364.066297837067395, 5863414.311534740030766 ], [ 1387381.839409928303212, 5863460.427046488039196 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_802_generated", "manhole_dn": "manhole_803_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387381.839409928303212, 5863460.427046488039196 ], [ 1387403.429578960640356, 5863504.96100580971688 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_803_generated", "manhole_dn": "manhole_804_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387403.429578960640356, 5863504.96100580971688 ], [ 1387425.140452897874638, 5863549.440256260335445 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_804_generated", "manhole_dn": "manhole_805_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387425.140452897874638, 5863549.440256260335445 ], [ 1387446.851326835108921, 5863593.91950671095401 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_805_generated", "manhole_dn": "manhole_806_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387446.851326835108921, 5863593.91950671095401 ], [ 1387467.528695637593046, 5863638.888379830867052 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 774.5, "invlev_up": 759.5, "invlev_dn": 772.0, "manhole_up": "manhole_806_generated", "manhole_dn": "manhole_807_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387467.528695637593046, 5863638.888379830867052 ], [ 1387488.196078018052503, 5863683.861984014511108 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.5, "elevtn_dn": 762.0, "invlev_up": 772.0, "invlev_dn": 759.5, "manhole_up": "manhole_807_generated", "manhole_dn": "manhole_808_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387488.196078018052503, 5863683.861984014511108 ], [ 1387508.863468252588063, 5863728.835584589280188 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_808_generated", "manhole_dn": "manhole_809_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387508.863468252588063, 5863728.835584589280188 ], [ 1387529.53130904212594, 5863773.808978110551834 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_809_generated", "manhole_dn": "manhole_810_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387529.53130904212594, 5863773.808978110551834 ], [ 1387553.168002701364458, 5863817.17347530182451 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_810_generated", "manhole_dn": "manhole_811_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387553.168002701364458, 5863817.17347530182451 ], [ 1387579.562712850514799, 5863859.043333718553185 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 777.0, "invlev_up": 759.5, "invlev_dn": 774.5, "manhole_up": "manhole_811_generated", "manhole_dn": "manhole_812_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387579.562712850514799, 5863859.043333718553185 ], [ 1387605.957422999665141, 5863900.913192136213183 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.0, "elevtn_dn": 762.0, "invlev_up": 774.5, "invlev_dn": 759.5, "manhole_up": "manhole_812_generated", "manhole_dn": "manhole_813_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387605.957422999665141, 5863900.913192136213183 ], [ 1387632.352133149048313, 5863942.783050553873181 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E48", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_813_generated", "manhole_dn": "manhole_814_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387632.352133149048313, 5863942.783050553873181 ], [ 1387658.746843298198655, 5863984.652908970601857 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E49", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_814_generated", "manhole_dn": "manhole_815_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387658.746843298198655, 5863984.652908970601857 ], [ 1387685.893106181640178, 5864026.029537551105022 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E50", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_815_generated", "manhole_dn": "manhole_816_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387685.893106181640178, 5864026.029537551105022 ], [ 1387711.231136992340907, 5864068.42725711222738 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E51", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_816_generated", "manhole_dn": "manhole_817_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387711.231136992340907, 5864068.42725711222738 ], [ 1387731.020947323646396, 5864113.414904261007905 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E52", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_817_generated", "manhole_dn": "manhole_818_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387731.020947323646396, 5864113.414904261007905 ], [ 1387737.361907477490604, 5864162.342261835932732 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E53", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_818_generated", "manhole_dn": "manhole_819_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387737.361907477490604, 5864162.342261835932732 ], [ 1387732.727565656881779, 5864211.475179814733565 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E54", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_819_generated", "manhole_dn": "manhole_820_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387732.727565656881779, 5864211.475179814733565 ], [ 1387717.67884943424724, 5864258.627082298509777 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E55", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_820_generated", "manhole_dn": "manhole_821_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387717.67884943424724, 5864258.627082298509777 ], [ 1387709.67210421175696, 5864307.23127611912787 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E56", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 768.0, "invlev_up": 759.5, "invlev_dn": 765.5, "manhole_up": "manhole_821_generated", "manhole_dn": "manhole_822_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387709.67210421175696, 5864307.23127611912787 ], [ 1387707.11288084089756, 5864356.66017600055784 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E57", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_822_generated", "manhole_dn": "manhole_823_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387707.11288084089756, 5864356.66017600055784 ], [ 1387709.591797993984073, 5864406.012949175201356 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E58", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_823_generated", "manhole_dn": "manhole_824_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387709.591797993984073, 5864406.012949175201356 ], [ 1387713.643261310644448, 5864455.341961052268744 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E59", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 777.20001220703125, "invlev_up": 765.5, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_824_generated", "manhole_dn": "manhole_825_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387713.643261310644448, 5864455.341961052268744 ], [ 1387715.877521668095142, 5864504.642317942343652 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E60", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 774.70001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_825_generated", "manhole_dn": "manhole_826_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387715.877521668095142, 5864504.642317942343652 ], [ 1387708.68023270717822, 5864553.426558391191065 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E61", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 774.70001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_826_generated", "manhole_dn": "manhole_827_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387708.68023270717822, 5864553.426558391191065 ], [ 1387690.790250770282, 5864599.575386263430119 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E62", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 810.60003662109375, "invlev_up": 774.70001220703125, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_827_generated", "manhole_dn": "manhole_828_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387690.790250770282, 5864599.575386263430119 ], [ 1387672.900268833618611, 5864645.724214136600494 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E63", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 810.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_828_generated", "manhole_dn": "manhole_829_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387672.900268833618611, 5864645.724214136600494 ], [ 1387659.931900478899479, 5864692.98388583958149 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E64", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 810.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_829_generated", "manhole_dn": "manhole_830_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387659.931900478899479, 5864692.98388583958149 ], [ 1387659.223570322152227, 5864742.029465307481587 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E65", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_830_generated", "manhole_dn": "manhole_831_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387659.223570322152227, 5864742.029465307481587 ], [ 1387675.926896508783102, 5864788.273513910360634 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E66", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 774.10003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 771.60003662109375, "manhole_up": "manhole_831_generated", "manhole_dn": "manhole_832_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387675.926896508783102, 5864788.273513910360634 ], [ 1387702.296291569946334, 5864830.159320239908993 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E67", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.10003662109375, "elevtn_dn": 774.10003662109375, "invlev_up": 771.60003662109375, "invlev_dn": 771.60003662109375, "manhole_up": "manhole_832_generated", "manhole_dn": "manhole_833_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387702.296291569946334, 5864830.159320239908993 ], [ 1387728.665686630876735, 5864872.045126569457352 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E68", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.10003662109375, "elevtn_dn": 782.5, "invlev_up": 771.60003662109375, "invlev_dn": 780.0, "manhole_up": "manhole_833_generated", "manhole_dn": "manhole_834_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387728.665686630876735, 5864872.045126569457352 ], [ 1387751.608185108983889, 5864915.528788692317903 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E69", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 782.5, "invlev_up": 780.0, "invlev_dn": 780.0, "manhole_up": "manhole_834_generated", "manhole_dn": "manhole_835_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387751.608185108983889, 5864915.528788692317903 ], [ 1387766.741664502769709, 5864962.653554677963257 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E70", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 782.5, "invlev_up": 780.0, "invlev_dn": 780.0, "manhole_up": "manhole_835_generated", "manhole_dn": "manhole_836_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387766.741664502769709, 5864962.653554677963257 ], [ 1387778.99191950308159, 5865010.246724016033113 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E71", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 820.20001220703125, "invlev_up": 780.0, "invlev_dn": 817.70001220703125, "manhole_up": "manhole_836_generated", "manhole_dn": "manhole_837_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387778.99191950308159, 5865010.246724016033113 ], [ 1387779.554608268430457, 5865059.738633952103555 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E72", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.20001220703125, "elevtn_dn": 820.20001220703125, "invlev_up": 817.70001220703125, "invlev_dn": 817.70001220703125, "manhole_up": "manhole_837_generated", "manhole_dn": "manhole_838_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387779.554608268430457, 5865059.738633952103555 ], [ 1387780.117297033779323, 5865109.230543887242675 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E73", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.20001220703125, "elevtn_dn": 834.60003662109375, "invlev_up": 817.70001220703125, "invlev_dn": 832.10003662109375, "manhole_up": "manhole_838_generated", "manhole_dn": "manhole_839_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387780.117297033779323, 5865109.230543887242675 ], [ 1387782.917817069217563, 5865158.566991245374084 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E74", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 834.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 832.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_839_generated", "manhole_dn": "manhole_840_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387782.917817069217563, 5865158.566991245374084 ], [ 1387789.203931836877018, 5865207.661293652839959 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E75", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_840_generated", "manhole_dn": "manhole_841_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387789.203931836877018, 5865207.661293652839959 ], [ 1387795.490046604769304, 5865256.755596060305834 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E76", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_841_generated", "manhole_dn": "manhole_842_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387795.490046604769304, 5865256.755596060305834 ], [ 1387804.549934879876673, 5865305.332479531876743 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E77", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 809.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_842_generated", "manhole_dn": "manhole_843_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387804.549934879876673, 5865305.332479531876743 ], [ 1387816.386747075244784, 5865353.391356389038265 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E78", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 809.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_843_generated", "manhole_dn": "manhole_844_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387816.386747075244784, 5865353.391356389038265 ], [ 1387828.223559270845726, 5865401.450233246199787 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E79", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 802.5, "invlev_up": 809.10003662109375, "invlev_dn": 800.0, "manhole_up": "manhole_844_generated", "manhole_dn": "manhole_845_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387828.223559270845726, 5865401.450233246199787 ], [ 1387842.96627543354407, 5865448.679594250395894 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E80", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 802.5, "invlev_up": 800.0, "invlev_dn": 800.0, "manhole_up": "manhole_845_generated", "manhole_dn": "manhole_846_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387842.96627543354407, 5865448.679594250395894 ], [ 1387858.283513206522912, 5865495.744953005574644 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E81", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 802.5, "invlev_up": 800.0, "invlev_dn": 800.0, "manhole_up": "manhole_846_generated", "manhole_dn": "manhole_847_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387858.283513206522912, 5865495.744953005574644 ], [ 1387872.788357679266483, 5865543.026506381109357 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E82", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 778.20001220703125, "invlev_up": 800.0, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_847_generated", "manhole_dn": "manhole_848_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387872.788357679266483, 5865543.026506381109357 ], [ 1387882.890574953285977, 5865591.479689701460302 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E83", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_848_generated", "manhole_dn": "manhole_849_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387882.890574953285977, 5865591.479689701460302 ], [ 1387892.992792227305472, 5865639.932873022742569 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E84", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_849_generated", "manhole_dn": "manhole_850_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387892.992792227305472, 5865639.932873022742569 ], [ 1387903.095009501324967, 5865688.386056343093514 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_41_E85", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_850_generated", "manhole_dn": "manhole_851_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387903.095009501324967, 5865688.386056343093514 ], [ 1387913.197226775344461, 5865736.839239663444459 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_42_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 830.9000244140625, "invlev_up": 828.4000244140625, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_852_generated", "manhole_dn": "manhole_853_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387767.438602478476241, 5866395.894650792703032 ], [ 1387758.181959156645462, 5866444.388786932453513 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_42_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 830.9000244140625, "invlev_up": 828.4000244140625, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_853_generated", "manhole_dn": "manhole_854_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387758.181959156645462, 5866444.388786932453513 ], [ 1387748.925315835047513, 5866492.882923071272671 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_42_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 816.5, "invlev_up": 828.4000244140625, "invlev_dn": 814.0, "manhole_up": "manhole_854_generated", "manhole_dn": "manhole_855_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387748.925315835047513, 5866492.882923071272671 ], [ 1387739.668672513216734, 5866541.377059211023152 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_42_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.5, "elevtn_dn": 816.5, "invlev_up": 814.0, "invlev_dn": 814.0, "manhole_up": "manhole_855_generated", "manhole_dn": "manhole_856_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387739.668672513216734, 5866541.377059211023152 ], [ 1387730.412029191618785, 5866589.87119534984231 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_42_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.5, "elevtn_dn": 816.10003662109375, "invlev_up": 814.0, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_856_generated", "manhole_dn": "manhole_857_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387730.412029191618785, 5866589.87119534984231 ], [ 1387721.155385869788006, 5866638.365331489592791 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_42_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 816.10003662109375, "invlev_up": 813.60003662109375, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_857_generated", "manhole_dn": "manhole_858_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387721.155385869788006, 5866638.365331489592791 ], [ 1387711.868742506252602, 5866686.853722332976758 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_42_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 816.10003662109375, "invlev_up": 813.60003662109375, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_858_generated", "manhole_dn": "manhole_859_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387711.868742506252602, 5866686.853722332976758 ], [ 1387702.553355348296463, 5866735.336608462966979 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_42_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 802.4000244140625, "invlev_up": 813.60003662109375, "invlev_dn": 799.9000244140625, "manhole_up": "manhole_859_generated", "manhole_dn": "manhole_860_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387702.553355348296463, 5866735.336608462966979 ], [ 1387692.161796326050535, 5866783.420620376244187 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_43_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_43", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_43", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_861_generated", "manhole_dn": "manhole_862_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387809.534624515566975, 5866309.639251782558858 ], [ 1387788.486613497138023, 5866352.766951287165284 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_43_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_43", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_43", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 830.9000244140625, "invlev_up": 803.70001220703125, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_862_generated", "manhole_dn": "manhole_852_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387788.486613497138023, 5866352.766951287165284 ], [ 1387767.438602478476241, 5866395.894650792703032 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_44_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 840.10003662109375, "invlev_up": 828.4000244140625, "invlev_dn": 837.60003662109375, "manhole_up": "manhole_852_generated", "manhole_dn": "manhole_863_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387767.438602478476241, 5866395.894650792703032 ], [ 1387774.73306847945787, 5866351.644692087545991 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_44_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 840.10003662109375, "elevtn_dn": 806.20001220703125, "invlev_up": 837.60003662109375, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_863_generated", "manhole_dn": "manhole_864_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387774.73306847945787, 5866351.644692087545991 ], [ 1387787.219046234386042, 5866308.756401930935681 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_44_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_864_generated", "manhole_dn": "manhole_865_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387787.219046234386042, 5866308.756401930935681 ], [ 1387802.581935805035755, 5866266.622689731419086 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_44_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_865_generated", "manhole_dn": "manhole_866_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387802.581935805035755, 5866266.622689731419086 ], [ 1387818.989883717847988, 5866224.886323318816721 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_44_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_866_generated", "manhole_dn": "manhole_867_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387818.989883717847988, 5866224.886323318816721 ], [ 1387838.767447788733989, 5866184.784887914545834 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_44_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_867_generated", "manhole_dn": "manhole_868_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387838.767447788733989, 5866184.784887914545834 ], [ 1387862.375427621416748, 5866146.679679537191987 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_44_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 803.9000244140625, "invlev_up": 825.20001220703125, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_868_generated", "manhole_dn": "manhole_869_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387862.375427621416748, 5866146.679679537191987 ], [ 1387890.316308293025941, 5866111.904927220195532 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_44_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_869_generated", "manhole_dn": "manhole_870_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387890.316308293025941, 5866111.904927220195532 ], [ 1387932.086585889104754, 5866099.149365295656025 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_45_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_45", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_871_generated", "manhole_dn": "manhole_872_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387931.614702571649104, 5866170.542120457626879 ], [ 1387899.497387683717534, 5866203.806988564319909 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_45_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_45", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 806.20001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_872_generated", "manhole_dn": "manhole_873_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387899.497387683717534, 5866203.806988564319909 ], [ 1387869.509799961000681, 5866239.084409636445343 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_45_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_45", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_873_generated", "manhole_dn": "manhole_874_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387869.509799961000681, 5866239.084409636445343 ], [ 1387839.522212238283828, 5866274.361830709502101 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_45_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_45", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_874_generated", "manhole_dn": "manhole_861_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387839.522212238283828, 5866274.361830709502101 ], [ 1387809.534624515566975, 5866309.639251782558858 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_46_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_870_generated", "manhole_dn": "manhole_875_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387932.086585889104754, 5866099.149365295656025 ], [ 1387908.367353544337675, 5866141.903963415883482 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_46_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_875_generated", "manhole_dn": "manhole_876_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387908.367353544337675, 5866141.903963415883482 ], [ 1387876.955022902460769, 5866179.987773489207029 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_46_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 827.70001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_876_generated", "manhole_dn": "manhole_877_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387876.955022902460769, 5866179.987773489207029 ], [ 1387847.458594153402373, 5866219.470102892257273 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_46_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_877_generated", "manhole_dn": "manhole_878_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387847.458594153402373, 5866219.470102892257273 ], [ 1387823.639855962945148, 5866262.662997540086508 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_46_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_878_generated", "manhole_dn": "manhole_861_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387823.639855962945148, 5866262.662997540086508 ], [ 1387809.534624515566975, 5866309.639251782558858 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_47_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_879_generated", "manhole_dn": "manhole_880_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.443674022099003, 5865845.093254727311432 ], [ 1387943.318034203490242, 5865887.628139751963317 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_47_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_880_generated", "manhole_dn": "manhole_881_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387943.318034203490242, 5865887.628139751963317 ], [ 1387946.009428307646886, 5865930.175072746351361 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_47_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 816.70001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_881_generated", "manhole_dn": "manhole_882_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387946.009428307646886, 5865930.175072746351361 ], [ 1387948.700822412036359, 5865972.722005739808083 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_47_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_882_generated", "manhole_dn": "manhole_883_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387948.700822412036359, 5865972.722005739808083 ], [ 1387944.872250664513558, 5866015.105105520226061 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_47_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_883_generated", "manhole_dn": "manhole_884_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387944.872250664513558, 5866015.105105520226061 ], [ 1387940.047370131826028, 5866057.463170127011836 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_47_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 803.9000244140625, "invlev_up": 814.20001220703125, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_884_generated", "manhole_dn": "manhole_870_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.047370131826028, 5866057.463170127011836 ], [ 1387932.086585889104754, 5866099.149365295656025 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_48_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_48", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_48", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 786.29998779296875, "invlev_up": 801.4000244140625, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_870_generated", "manhole_dn": "manhole_885_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387932.086585889104754, 5866099.149365295656025 ], [ 1387975.279995472636074, 5866107.425722245126963 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E125", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.5, "elevtn_dn": 910.4000244140625, "invlev_up": 907.0, "invlev_dn": 907.9000244140625, "manhole_up": "manhole_886_generated", "manhole_dn": "manhole_887_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392926.966794768813998, 5866808.501405037939548 ], [ 1392879.417931769276038, 5866793.491589142940938 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E126", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 910.4000244140625, "elevtn_dn": 910.4000244140625, "invlev_up": 907.9000244140625, "invlev_dn": 907.9000244140625, "manhole_up": "manhole_887_generated", "manhole_dn": "manhole_888_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392879.417931769276038, 5866793.491589142940938 ], [ 1392831.869068769738078, 5866778.481773247942328 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E127", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 910.4000244140625, "elevtn_dn": 865.0, "invlev_up": 907.9000244140625, "invlev_dn": 862.5, "manhole_up": "manhole_888_generated", "manhole_dn": "manhole_889_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392831.869068769738078, 5866778.481773247942328 ], [ 1392784.320205770200118, 5866763.471957352943718 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E128", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 865.0, "elevtn_dn": 865.0, "invlev_up": 862.5, "invlev_dn": 862.5, "manhole_up": "manhole_889_generated", "manhole_dn": "manhole_890_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392784.320205770200118, 5866763.471957352943718 ], [ 1392736.771342770429328, 5866748.462141457945108 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E129", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 865.0, "elevtn_dn": 878.4000244140625, "invlev_up": 862.5, "invlev_dn": 875.9000244140625, "manhole_up": "manhole_890_generated", "manhole_dn": "manhole_891_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392736.771342770429328, 5866748.462141457945108 ], [ 1392689.222479770891368, 5866733.452325562946498 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E130", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 878.4000244140625, "elevtn_dn": 878.4000244140625, "invlev_up": 875.9000244140625, "invlev_dn": 875.9000244140625, "manhole_up": "manhole_891_generated", "manhole_dn": "manhole_892_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392689.222479770891368, 5866733.452325562946498 ], [ 1392641.673616771353409, 5866718.442509667947888 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E131", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 878.4000244140625, "elevtn_dn": 904.9000244140625, "invlev_up": 875.9000244140625, "invlev_dn": 902.4000244140625, "manhole_up": "manhole_892_generated", "manhole_dn": "manhole_893_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392641.673616771353409, 5866718.442509667947888 ], [ 1392594.124753771815449, 5866703.432693773880601 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E132", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 904.9000244140625, "elevtn_dn": 904.9000244140625, "invlev_up": 902.4000244140625, "invlev_dn": 902.4000244140625, "manhole_up": "manhole_893_generated", "manhole_dn": "manhole_894_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392594.124753771815449, 5866703.432693773880601 ], [ 1392546.575890772277489, 5866688.422877878881991 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E133", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 904.9000244140625, "elevtn_dn": 931.5, "invlev_up": 902.4000244140625, "invlev_dn": 929.0, "manhole_up": "manhole_894_generated", "manhole_dn": "manhole_895_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392546.575890772277489, 5866688.422877878881991 ], [ 1392499.02702777273953, 5866673.413061983883381 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E134", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 931.5, "elevtn_dn": 931.5, "invlev_up": 929.0, "invlev_dn": 929.0, "manhole_up": "manhole_895_generated", "manhole_dn": "manhole_896_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392499.02702777273953, 5866673.413061983883381 ], [ 1392451.47816477320157, 5866658.403246088884771 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E135", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 931.5, "elevtn_dn": 926.29998779296875, "invlev_up": 929.0, "invlev_dn": 923.79998779296875, "manhole_up": "manhole_896_generated", "manhole_dn": "manhole_897_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392451.47816477320157, 5866658.403246088884771 ], [ 1392403.92930177366361, 5866643.393430193886161 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E136", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 926.29998779296875, "elevtn_dn": 849.79998779296875, "invlev_up": 923.79998779296875, "invlev_dn": 847.29998779296875, "manhole_up": "manhole_897_generated", "manhole_dn": "manhole_898_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392403.92930177366361, 5866643.393430193886161 ], [ 1392356.380438774125651, 5866628.383614298887551 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E137", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 849.79998779296875, "elevtn_dn": 875.20001220703125, "invlev_up": 847.29998779296875, "invlev_dn": 872.70001220703125, "manhole_up": "manhole_898_generated", "manhole_dn": "manhole_899_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392356.380438774125651, 5866628.383614298887551 ], [ 1392308.831575774587691, 5866613.373798403888941 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E138", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 875.20001220703125, "elevtn_dn": 875.20001220703125, "invlev_up": 872.70001220703125, "invlev_dn": 872.70001220703125, "manhole_up": "manhole_899_generated", "manhole_dn": "manhole_900_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392308.831575774587691, 5866613.373798403888941 ], [ 1392261.282712775049731, 5866598.363982509821653 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E139", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 875.20001220703125, "elevtn_dn": 928.10003662109375, "invlev_up": 872.70001220703125, "invlev_dn": 925.60003662109375, "manhole_up": "manhole_900_generated", "manhole_dn": "manhole_901_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392261.282712775049731, 5866598.363982509821653 ], [ 1392213.733849775511771, 5866583.354166614823043 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E140", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 928.10003662109375, "elevtn_dn": 928.10003662109375, "invlev_up": 925.60003662109375, "invlev_dn": 925.60003662109375, "manhole_up": "manhole_901_generated", "manhole_dn": "manhole_902_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392213.733849775511771, 5866583.354166614823043 ], [ 1392166.184986775973812, 5866568.344350719824433 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E141", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 928.10003662109375, "elevtn_dn": 936.79998779296875, "invlev_up": 925.60003662109375, "invlev_dn": 934.29998779296875, "manhole_up": "manhole_902_generated", "manhole_dn": "manhole_903_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392166.184986775973812, 5866568.344350719824433 ], [ 1392119.234377897810191, 5866551.59017149079591 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E142", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 936.79998779296875, "elevtn_dn": 936.79998779296875, "invlev_up": 934.29998779296875, "invlev_dn": 934.29998779296875, "manhole_up": "manhole_903_generated", "manhole_dn": "manhole_904_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392119.234377897810191, 5866551.59017149079591 ], [ 1392072.481987217208371, 5866534.25803626794368 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E143", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 936.79998779296875, "elevtn_dn": 929.79998779296875, "invlev_up": 934.29998779296875, "invlev_dn": 927.29998779296875, "manhole_up": "manhole_904_generated", "manhole_dn": "manhole_905_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392072.481987217208371, 5866534.25803626794368 ], [ 1392025.729596536839381, 5866516.925901044160128 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E144", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 929.79998779296875, "elevtn_dn": 892.29998779296875, "invlev_up": 927.29998779296875, "invlev_dn": 889.79998779296875, "manhole_up": "manhole_905_generated", "manhole_dn": "manhole_906_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392025.729596536839381, 5866516.925901044160128 ], [ 1391978.977205856470391, 5866499.593765820376575 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E145", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 892.29998779296875, "elevtn_dn": 911.4000244140625, "invlev_up": 889.79998779296875, "invlev_dn": 908.9000244140625, "manhole_up": "manhole_906_generated", "manhole_dn": "manhole_907_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391978.977205856470391, 5866499.593765820376575 ], [ 1391932.224815175868571, 5866482.261630596593022 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E146", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.4000244140625, "elevtn_dn": 911.4000244140625, "invlev_up": 908.9000244140625, "invlev_dn": 908.9000244140625, "manhole_up": "manhole_907_generated", "manhole_dn": "manhole_908_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391932.224815175868571, 5866482.261630596593022 ], [ 1391885.472424495499581, 5866464.92949537280947 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E147", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.4000244140625, "elevtn_dn": 933.20001220703125, "invlev_up": 908.9000244140625, "invlev_dn": 930.70001220703125, "manhole_up": "manhole_908_generated", "manhole_dn": "manhole_909_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391885.472424495499581, 5866464.92949537280947 ], [ 1391838.720033814897761, 5866447.59736014995724 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E148", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.20001220703125, "elevtn_dn": 933.20001220703125, "invlev_up": 930.70001220703125, "invlev_dn": 930.70001220703125, "manhole_up": "manhole_909_generated", "manhole_dn": "manhole_910_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391838.720033814897761, 5866447.59736014995724 ], [ 1391791.967643134528771, 5866430.265224926173687 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E149", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.20001220703125, "elevtn_dn": 939.4000244140625, "invlev_up": 930.70001220703125, "invlev_dn": 936.9000244140625, "manhole_up": "manhole_910_generated", "manhole_dn": "manhole_911_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391791.967643134528771, 5866430.265224926173687 ], [ 1391745.215252453926951, 5866412.933089702390134 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E150", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 939.4000244140625, "elevtn_dn": 939.4000244140625, "invlev_up": 936.9000244140625, "invlev_dn": 936.9000244140625, "manhole_up": "manhole_911_generated", "manhole_dn": "manhole_912_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391745.215252453926951, 5866412.933089702390134 ], [ 1391698.462861773557961, 5866395.600954478606582 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E151", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 939.4000244140625, "elevtn_dn": 952.70001220703125, "invlev_up": 936.9000244140625, "invlev_dn": 950.20001220703125, "manhole_up": "manhole_912_generated", "manhole_dn": "manhole_913_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391698.462861773557961, 5866395.600954478606582 ], [ 1391651.710471092956141, 5866378.268819254823029 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E152", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.70001220703125, "elevtn_dn": 889.4000244140625, "invlev_up": 950.20001220703125, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_913_generated", "manhole_dn": "manhole_914_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391651.710471092956141, 5866378.268819254823029 ], [ 1391604.958080412587151, 5866360.936684031039476 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E153", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 848.70001220703125, "invlev_up": 886.9000244140625, "invlev_dn": 846.20001220703125, "manhole_up": "manhole_914_generated", "manhole_dn": "manhole_915_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391604.958080412587151, 5866360.936684031039476 ], [ 1391558.205689732218161, 5866343.604548808187246 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E154", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 848.70001220703125, "elevtn_dn": 848.70001220703125, "invlev_up": 846.20001220703125, "invlev_dn": 846.20001220703125, "manhole_up": "manhole_915_generated", "manhole_dn": "manhole_916_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391558.205689732218161, 5866343.604548808187246 ], [ 1391511.453299051616341, 5866326.272413584403694 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E155", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 848.70001220703125, "elevtn_dn": 846.0, "invlev_up": 846.20001220703125, "invlev_dn": 843.5, "manhole_up": "manhole_916_generated", "manhole_dn": "manhole_917_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391511.453299051616341, 5866326.272413584403694 ], [ 1391464.700908371247351, 5866308.940278360620141 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E156", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.0, "elevtn_dn": 846.0, "invlev_up": 843.5, "invlev_dn": 843.5, "manhole_up": "manhole_917_generated", "manhole_dn": "manhole_918_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391464.700908371247351, 5866308.940278360620141 ], [ 1391417.948517690645531, 5866291.608143136836588 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E157", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.0, "elevtn_dn": 849.9000244140625, "invlev_up": 843.5, "invlev_dn": 847.4000244140625, "manhole_up": "manhole_918_generated", "manhole_dn": "manhole_919_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391417.948517690645531, 5866291.608143136836588 ], [ 1391371.196127010276541, 5866274.276007913053036 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E158", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 849.9000244140625, "elevtn_dn": 849.9000244140625, "invlev_up": 847.4000244140625, "invlev_dn": 847.4000244140625, "manhole_up": "manhole_919_generated", "manhole_dn": "manhole_920_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391371.196127010276541, 5866274.276007913053036 ], [ 1391321.986832652939484, 5866269.550851707346737 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E159", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 849.9000244140625, "elevtn_dn": 895.70001220703125, "invlev_up": 847.4000244140625, "invlev_dn": 893.20001220703125, "manhole_up": "manhole_920_generated", "manhole_dn": "manhole_921_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391321.986832652939484, 5866269.550851707346737 ], [ 1391272.147464629728347, 5866268.058758955448866 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E160", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 895.70001220703125, "elevtn_dn": 895.70001220703125, "invlev_up": 893.20001220703125, "invlev_dn": 893.20001220703125, "manhole_up": "manhole_921_generated", "manhole_dn": "manhole_922_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391272.147464629728347, 5866268.058758955448866 ], [ 1391222.30809660628438, 5866266.566666204482317 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E161", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 895.70001220703125, "elevtn_dn": 932.0, "invlev_up": 893.20001220703125, "invlev_dn": 929.5, "manhole_up": "manhole_922_generated", "manhole_dn": "manhole_923_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391222.30809660628438, 5866266.566666204482317 ], [ 1391172.468728582840413, 5866265.074573452584445 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E162", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 932.0, "invlev_up": 929.5, "invlev_dn": 929.5, "manhole_up": "manhole_923_generated", "manhole_dn": "manhole_924_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391172.468728582840413, 5866265.074573452584445 ], [ 1391122.629360559629276, 5866263.582480700686574 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E163", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 915.20001220703125, "invlev_up": 929.5, "invlev_dn": 912.70001220703125, "manhole_up": "manhole_924_generated", "manhole_dn": "manhole_925_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391122.629360559629276, 5866263.582480700686574 ], [ 1391072.789992536185309, 5866262.090387949720025 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E164", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.20001220703125, "elevtn_dn": 880.70001220703125, "invlev_up": 912.70001220703125, "invlev_dn": 878.20001220703125, "manhole_up": "manhole_925_generated", "manhole_dn": "manhole_926_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391072.789992536185309, 5866262.090387949720025 ], [ 1391022.950624512741342, 5866260.598295197822154 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E165", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 880.70001220703125, "elevtn_dn": 880.70001220703125, "invlev_up": 878.20001220703125, "invlev_dn": 878.20001220703125, "manhole_up": "manhole_926_generated", "manhole_dn": "manhole_927_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391022.950624512741342, 5866260.598295197822154 ], [ 1390973.111256489530206, 5866259.106202445924282 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E166", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 880.70001220703125, "elevtn_dn": 889.4000244140625, "invlev_up": 878.20001220703125, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_927_generated", "manhole_dn": "manhole_928_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390973.111256489530206, 5866259.106202445924282 ], [ 1390923.271888466086239, 5866257.614109694957733 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E167", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 889.4000244140625, "invlev_up": 886.9000244140625, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_928_generated", "manhole_dn": "manhole_929_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390923.271888466086239, 5866257.614109694957733 ], [ 1390873.432520442642272, 5866256.122016943059862 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E168", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 935.79998779296875, "invlev_up": 886.9000244140625, "invlev_dn": 933.29998779296875, "manhole_up": "manhole_929_generated", "manhole_dn": "manhole_930_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390873.432520442642272, 5866256.122016943059862 ], [ 1390823.593152419198304, 5866254.62992419116199 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E169", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.79998779296875, "elevtn_dn": 935.79998779296875, "invlev_up": 933.29998779296875, "invlev_dn": 933.29998779296875, "manhole_up": "manhole_930_generated", "manhole_dn": "manhole_931_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390823.593152419198304, 5866254.62992419116199 ], [ 1390773.753784395987168, 5866253.137831440195441 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E170", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.79998779296875, "elevtn_dn": 957.79998779296875, "invlev_up": 933.29998779296875, "invlev_dn": 955.29998779296875, "manhole_up": "manhole_931_generated", "manhole_dn": "manhole_932_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390773.753784395987168, 5866253.137831440195441 ], [ 1390723.914416372543201, 5866251.64573868829757 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E171", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.79998779296875, "elevtn_dn": 957.79998779296875, "invlev_up": 955.29998779296875, "invlev_dn": 955.29998779296875, "manhole_up": "manhole_932_generated", "manhole_dn": "manhole_933_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390723.914416372543201, 5866251.64573868829757 ], [ 1390674.075048349099234, 5866250.153645936399698 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E172", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.79998779296875, "elevtn_dn": 957.0, "invlev_up": 955.29998779296875, "invlev_dn": 954.5, "manhole_up": "manhole_933_generated", "manhole_dn": "manhole_934_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390674.075048349099234, 5866250.153645936399698 ], [ 1390624.235680325888097, 5866248.661553185433149 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E173", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.0, "elevtn_dn": 957.0, "invlev_up": 954.5, "invlev_dn": 954.5, "manhole_up": "manhole_934_generated", "manhole_dn": "manhole_935_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390624.235680325888097, 5866248.661553185433149 ], [ 1390574.39631230244413, 5866247.169460433535278 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E174", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.0, "elevtn_dn": 964.5, "invlev_up": 954.5, "invlev_dn": 962.0, "manhole_up": "manhole_935_generated", "manhole_dn": "manhole_936_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390574.39631230244413, 5866247.169460433535278 ], [ 1390524.556944279000163, 5866245.677367681637406 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E175", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 964.5, "invlev_up": 962.0, "invlev_dn": 962.0, "manhole_up": "manhole_936_generated", "manhole_dn": "manhole_937_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390524.556944279000163, 5866245.677367681637406 ], [ 1390474.717576255789027, 5866244.185274930670857 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E176", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 948.5, "invlev_up": 962.0, "invlev_dn": 946.0, "manhole_up": "manhole_937_generated", "manhole_dn": "manhole_938_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390474.717576255789027, 5866244.185274930670857 ], [ 1390424.87820823234506, 5866242.693182178772986 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E177", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 948.5, "elevtn_dn": 970.10003662109375, "invlev_up": 946.0, "invlev_dn": 967.60003662109375, "manhole_up": "manhole_938_generated", "manhole_dn": "manhole_939_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390424.87820823234506, 5866242.693182178772986 ], [ 1390375.038840208901092, 5866241.201089426875114 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E178", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 970.10003662109375, "elevtn_dn": 970.10003662109375, "invlev_up": 967.60003662109375, "invlev_dn": 967.60003662109375, "manhole_up": "manhole_939_generated", "manhole_dn": "manhole_940_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390375.038840208901092, 5866241.201089426875114 ], [ 1390325.199472185689956, 5866239.708996675908566 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E179", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 970.10003662109375, "elevtn_dn": 975.4000244140625, "invlev_up": 967.60003662109375, "invlev_dn": 972.9000244140625, "manhole_up": "manhole_940_generated", "manhole_dn": "manhole_941_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390325.199472185689956, 5866239.708996675908566 ], [ 1390275.360104162245989, 5866238.216903924010694 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E180", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 975.4000244140625, "elevtn_dn": 975.4000244140625, "invlev_up": 972.9000244140625, "invlev_dn": 972.9000244140625, "manhole_up": "manhole_941_generated", "manhole_dn": "manhole_942_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390275.360104162245989, 5866238.216903924010694 ], [ 1390225.520736138802022, 5866236.724811173044145 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E181", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 975.4000244140625, "elevtn_dn": 1034.5, "invlev_up": 972.9000244140625, "invlev_dn": 1032.0, "manhole_up": "manhole_942_generated", "manhole_dn": "manhole_943_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390225.520736138802022, 5866236.724811173044145 ], [ 1390175.681368115358055, 5866235.232718421146274 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E182", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1034.5, "elevtn_dn": 1034.5, "invlev_up": 1032.0, "invlev_dn": 1032.0, "manhole_up": "manhole_943_generated", "manhole_dn": "manhole_944_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390175.681368115358055, 5866235.232718421146274 ], [ 1390125.842000092146918, 5866233.740625669248402 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E183", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1034.5, "elevtn_dn": 1053.9000244140625, "invlev_up": 1032.0, "invlev_dn": 1051.4000244140625, "manhole_up": "manhole_944_generated", "manhole_dn": "manhole_945_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390125.842000092146918, 5866233.740625669248402 ], [ 1390076.002632068702951, 5866232.248532918281853 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E184", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.9000244140625, "elevtn_dn": 956.9000244140625, "invlev_up": 1051.4000244140625, "invlev_dn": 954.4000244140625, "manhole_up": "manhole_945_generated", "manhole_dn": "manhole_946_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390076.002632068702951, 5866232.248532918281853 ], [ 1390026.163264045258984, 5866230.756440166383982 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E185", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 956.9000244140625, "elevtn_dn": 988.79998779296875, "invlev_up": 954.4000244140625, "invlev_dn": 986.29998779296875, "manhole_up": "manhole_946_generated", "manhole_dn": "manhole_947_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390026.163264045258984, 5866230.756440166383982 ], [ 1389976.323896022047848, 5866229.26434741448611 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E186", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 988.79998779296875, "elevtn_dn": 988.79998779296875, "invlev_up": 986.29998779296875, "invlev_dn": 986.29998779296875, "manhole_up": "manhole_947_generated", "manhole_dn": "manhole_948_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389976.323896022047848, 5866229.26434741448611 ], [ 1389926.48452799860388, 5866227.772254663519561 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E187", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 988.79998779296875, "elevtn_dn": 1051.0999755859375, "invlev_up": 986.29998779296875, "invlev_dn": 1048.5999755859375, "manhole_up": "manhole_948_generated", "manhole_dn": "manhole_949_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389926.48452799860388, 5866227.772254663519561 ], [ 1389876.645159975159913, 5866226.28016191162169 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E188", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1051.0999755859375, "elevtn_dn": 1051.0999755859375, "invlev_up": 1048.5999755859375, "invlev_dn": 1048.5999755859375, "manhole_up": "manhole_949_generated", "manhole_dn": "manhole_950_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389876.645159975159913, 5866226.28016191162169 ], [ 1389826.805791951948777, 5866224.788069159723818 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E189", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1051.0999755859375, "elevtn_dn": 1066.9000244140625, "invlev_up": 1048.5999755859375, "invlev_dn": 1064.4000244140625, "manhole_up": "manhole_950_generated", "manhole_dn": "manhole_951_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389826.805791951948777, 5866224.788069159723818 ], [ 1389776.96642392850481, 5866223.295976408757269 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E190", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1066.9000244140625, "elevtn_dn": 1031.2000732421875, "invlev_up": 1064.4000244140625, "invlev_dn": 1028.7000732421875, "manhole_up": "manhole_951_generated", "manhole_dn": "manhole_952_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389776.96642392850481, 5866223.295976408757269 ], [ 1389727.141182830790058, 5866221.468200048431754 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E191", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1031.2000732421875, "elevtn_dn": 1031.2000732421875, "invlev_up": 1028.7000732421875, "invlev_dn": 1028.7000732421875, "manhole_up": "manhole_952_generated", "manhole_dn": "manhole_953_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389727.141182830790058, 5866221.468200048431754 ], [ 1389677.352675863076001, 5866218.767548334784806 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E192", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1031.2000732421875, "elevtn_dn": 986.60003662109375, "invlev_up": 1028.7000732421875, "invlev_dn": 984.10003662109375, "manhole_up": "manhole_953_generated", "manhole_dn": "manhole_954_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389677.352675863076001, 5866218.767548334784806 ], [ 1389627.564168895594776, 5866216.066896621137857 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E193", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 986.60003662109375, "elevtn_dn": 986.60003662109375, "invlev_up": 984.10003662109375, "invlev_dn": 984.10003662109375, "manhole_up": "manhole_954_generated", "manhole_dn": "manhole_955_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389627.564168895594776, 5866216.066896621137857 ], [ 1389577.775661927880719, 5866213.366244907490909 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E194", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 986.60003662109375, "elevtn_dn": 964.70001220703125, "invlev_up": 984.10003662109375, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_955_generated", "manhole_dn": "manhole_956_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389577.775661927880719, 5866213.366244907490909 ], [ 1389527.987154960166663, 5866210.665593194775283 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E195", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 964.70001220703125, "invlev_up": 962.20001220703125, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_956_generated", "manhole_dn": "manhole_957_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389527.987154960166663, 5866210.665593194775283 ], [ 1389478.198647992452607, 5866207.964941481128335 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E196", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 996.29998779296875, "invlev_up": 962.20001220703125, "invlev_dn": 993.79998779296875, "manhole_up": "manhole_957_generated", "manhole_dn": "manhole_958_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389478.198647992452607, 5866207.964941481128335 ], [ 1389428.41014102473855, 5866205.264289767481387 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E197", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 996.29998779296875, "elevtn_dn": 996.29998779296875, "invlev_up": 993.79998779296875, "invlev_dn": 993.79998779296875, "manhole_up": "manhole_958_generated", "manhole_dn": "manhole_959_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389428.41014102473855, 5866205.264289767481387 ], [ 1389378.621634057024494, 5866202.563638053834438 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E198", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 996.29998779296875, "elevtn_dn": 1030.4000244140625, "invlev_up": 993.79998779296875, "invlev_dn": 1027.9000244140625, "manhole_up": "manhole_959_generated", "manhole_dn": "manhole_960_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389378.621634057024494, 5866202.563638053834438 ], [ 1389328.833127089310437, 5866199.86298634018749 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E199", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1030.4000244140625, "elevtn_dn": 1030.4000244140625, "invlev_up": 1027.9000244140625, "invlev_dn": 1027.9000244140625, "manhole_up": "manhole_960_generated", "manhole_dn": "manhole_961_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389328.833127089310437, 5866199.86298634018749 ], [ 1389279.044620121829212, 5866197.162334626540542 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E200", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1030.4000244140625, "elevtn_dn": 1053.800048828125, "invlev_up": 1027.9000244140625, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_961_generated", "manhole_dn": "manhole_962_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389279.044620121829212, 5866197.162334626540542 ], [ 1389229.256113154115155, 5866194.461682912893593 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E201", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1053.800048828125, "invlev_up": 1051.300048828125, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_962_generated", "manhole_dn": "manhole_963_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389229.256113154115155, 5866194.461682912893593 ], [ 1389179.467606186401099, 5866191.761031199246645 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E202", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1067.5999755859375, "invlev_up": 1051.300048828125, "invlev_dn": 1065.0999755859375, "manhole_up": "manhole_963_generated", "manhole_dn": "manhole_964_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389179.467606186401099, 5866191.761031199246645 ], [ 1389129.679099218687043, 5866189.060379485599697 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E203", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1067.5999755859375, "elevtn_dn": 1070.7000732421875, "invlev_up": 1065.0999755859375, "invlev_dn": 1068.2000732421875, "manhole_up": "manhole_964_generated", "manhole_dn": "manhole_965_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389129.679099218687043, 5866189.060379485599697 ], [ 1389079.890592250972986, 5866186.359727771952748 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E204", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1070.7000732421875, "elevtn_dn": 1070.7000732421875, "invlev_up": 1068.2000732421875, "invlev_dn": 1068.2000732421875, "manhole_up": "manhole_965_generated", "manhole_dn": "manhole_966_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389079.890592250972986, 5866186.359727771952748 ], [ 1389030.10208528325893, 5866183.6590760583058 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E205", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1070.7000732421875, "elevtn_dn": 1075.0, "invlev_up": 1068.2000732421875, "invlev_dn": 1072.5, "manhole_up": "manhole_966_generated", "manhole_dn": "manhole_967_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389030.10208528325893, 5866183.6590760583058 ], [ 1388980.313578315777704, 5866180.958424345590174 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E206", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1075.0, "elevtn_dn": 1075.0, "invlev_up": 1072.5, "invlev_dn": 1072.5, "manhole_up": "manhole_967_generated", "manhole_dn": "manhole_968_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388980.313578315777704, 5866180.958424345590174 ], [ 1388930.525071348063648, 5866178.257772631943226 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E207", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1075.0, "elevtn_dn": 1074.0999755859375, "invlev_up": 1072.5, "invlev_dn": 1071.5999755859375, "manhole_up": "manhole_968_generated", "manhole_dn": "manhole_969_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388930.525071348063648, 5866178.257772631943226 ], [ 1388880.736564380349591, 5866175.557120918296278 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E208", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1074.0999755859375, "elevtn_dn": 1074.0999755859375, "invlev_up": 1071.5999755859375, "invlev_dn": 1071.5999755859375, "manhole_up": "manhole_969_generated", "manhole_dn": "manhole_970_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388880.736564380349591, 5866175.557120918296278 ], [ 1388830.948057412635535, 5866172.856469204649329 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E209", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1074.0999755859375, "elevtn_dn": 1053.800048828125, "invlev_up": 1071.5999755859375, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_970_generated", "manhole_dn": "manhole_971_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388830.948057412635535, 5866172.856469204649329 ], [ 1388781.159550444921479, 5866170.155817491002381 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E210", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1053.800048828125, "invlev_up": 1051.300048828125, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_971_generated", "manhole_dn": "manhole_972_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388781.159550444921479, 5866170.155817491002381 ], [ 1388731.371043477207422, 5866167.455165777355433 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E211", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1017.0, "invlev_up": 1051.300048828125, "invlev_dn": 1014.5, "manhole_up": "manhole_972_generated", "manhole_dn": "manhole_973_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388731.371043477207422, 5866167.455165777355433 ], [ 1388681.582536509493366, 5866164.754514063708484 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E212", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1017.0, "elevtn_dn": 1017.0, "invlev_up": 1014.5, "invlev_dn": 1014.5, "manhole_up": "manhole_973_generated", "manhole_dn": "manhole_974_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388681.582536509493366, 5866164.754514063708484 ], [ 1388631.79402954201214, 5866162.053862350061536 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E213", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1017.0, "elevtn_dn": 973.20001220703125, "invlev_up": 1014.5, "invlev_dn": 970.70001220703125, "manhole_up": "manhole_974_generated", "manhole_dn": "manhole_975_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388631.79402954201214, 5866162.053862350061536 ], [ 1388582.005522574298084, 5866159.353210636414587 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E214", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 973.20001220703125, "elevtn_dn": 973.20001220703125, "invlev_up": 970.70001220703125, "invlev_dn": 970.70001220703125, "manhole_up": "manhole_975_generated", "manhole_dn": "manhole_976_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388582.005522574298084, 5866159.353210636414587 ], [ 1388532.217015606584027, 5866156.652558922767639 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E215", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 973.20001220703125, "elevtn_dn": 935.20001220703125, "invlev_up": 970.70001220703125, "invlev_dn": 932.70001220703125, "manhole_up": "manhole_976_generated", "manhole_dn": "manhole_977_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388532.217015606584027, 5866156.652558922767639 ], [ 1388482.428508638869971, 5866153.951907209120691 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E216", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.20001220703125, "elevtn_dn": 935.20001220703125, "invlev_up": 932.70001220703125, "invlev_dn": 932.70001220703125, "manhole_up": "manhole_977_generated", "manhole_dn": "manhole_978_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388482.428508638869971, 5866153.951907209120691 ], [ 1388432.640001671155915, 5866151.251255496405065 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E217", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.20001220703125, "elevtn_dn": 895.79998779296875, "invlev_up": 932.70001220703125, "invlev_dn": 893.29998779296875, "manhole_up": "manhole_978_generated", "manhole_dn": "manhole_979_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388432.640001671155915, 5866151.251255496405065 ], [ 1388382.851494703441858, 5866148.550603782758117 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E218", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 895.79998779296875, "elevtn_dn": 852.60003662109375, "invlev_up": 893.29998779296875, "invlev_dn": 850.10003662109375, "manhole_up": "manhole_979_generated", "manhole_dn": "manhole_980_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388382.851494703441858, 5866148.550603782758117 ], [ 1388333.062987735960633, 5866145.849952069111168 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E219", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 852.60003662109375, "elevtn_dn": 852.60003662109375, "invlev_up": 850.10003662109375, "invlev_dn": 850.10003662109375, "manhole_up": "manhole_980_generated", "manhole_dn": "manhole_981_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388333.062987735960633, 5866145.849952069111168 ], [ 1388283.274480768246576, 5866143.14930035546422 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E220", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 852.60003662109375, "elevtn_dn": 818.4000244140625, "invlev_up": 850.10003662109375, "invlev_dn": 815.9000244140625, "manhole_up": "manhole_981_generated", "manhole_dn": "manhole_982_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388283.274480768246576, 5866143.14930035546422 ], [ 1388233.48597380053252, 5866140.448648641817272 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_49_E221", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.4000244140625, "elevtn_dn": 818.4000244140625, "invlev_up": 815.9000244140625, "invlev_dn": 815.9000244140625, "manhole_up": "manhole_982_generated", "manhole_dn": "manhole_983_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388233.48597380053252, 5866140.448648641817272 ], [ 1388183.697466832818463, 5866137.747996928170323 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_50_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 792.20001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_851_generated", "manhole_dn": "manhole_984_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387913.197226775344461, 5865736.839239663444459 ], [ 1387925.20445894007571, 5865784.545682998374104 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_50_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 804.4000244140625, "invlev_up": 792.20001220703125, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_984_generated", "manhole_dn": "manhole_985_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387925.20445894007571, 5865784.545682998374104 ], [ 1387937.21169110503979, 5865832.252126332372427 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_50_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_985_generated", "manhole_dn": "manhole_986_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387937.21169110503979, 5865832.252126332372427 ], [ 1387954.8270876808092, 5865878.043407939374447 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_50_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_986_generated", "manhole_dn": "manhole_987_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387954.8270876808092, 5865878.043407939374447 ], [ 1387967.620662312954664, 5865925.436966767534614 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_50_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 778.20001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_987_generated", "manhole_dn": "manhole_988_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387967.620662312954664, 5865925.436966767534614 ], [ 1387969.561903131194413, 5865974.386314341798425 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_50_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_988_generated", "manhole_dn": "manhole_989_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.561903131194413, 5865974.386314341798425 ], [ 1387968.98255812516436, 5866023.571071763522923 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_50_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_989_generated", "manhole_dn": "manhole_990_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387968.98255812516436, 5866023.571071763522923 ], [ 1387969.225197304505855, 5866072.657253311946988 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_50_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 786.29998779296875, "invlev_up": 775.70001220703125, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_990_generated", "manhole_dn": "manhole_991_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.225197304505855, 5866072.657253311946988 ], [ 1387988.247399942483753, 5866112.298415473662317 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_50_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 786.29998779296875, "invlev_up": 783.79998779296875, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_991_generated", "manhole_dn": "manhole_992_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387988.247399942483753, 5866112.298415473662317 ], [ 1388034.037428337847814, 5866130.255607943050563 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_51_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 786.29998779296875, "invlev_up": 783.79998779296875, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_992_generated", "manhole_dn": "manhole_993_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388034.037428337847814, 5866130.255607943050563 ], [ 1387988.210684564430267, 5866144.678138472139835 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_51_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 803.9000244140625, "invlev_up": 783.79998779296875, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_993_generated", "manhole_dn": "manhole_994_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387988.210684564430267, 5866144.678138472139835 ], [ 1387944.406121137319133, 5866164.065103021450341 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_51_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_994_generated", "manhole_dn": "manhole_995_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387944.406121137319133, 5866164.065103021450341 ], [ 1387898.376188111724332, 5866173.560075835324824 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_51_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 827.70001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_995_generated", "manhole_dn": "manhole_996_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387898.376188111724332, 5866173.560075835324824 ], [ 1387861.922560503939167, 5866145.113870099186897 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_51_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_996_generated", "manhole_dn": "manhole_997_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387861.922560503939167, 5866145.113870099186897 ], [ 1387862.597008766839281, 5866099.287653629668057 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_51_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_997_generated", "manhole_dn": "manhole_998_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387862.597008766839281, 5866099.287653629668057 ], [ 1387894.296242429409176, 5866064.31225199252367 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_51_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_998_generated", "manhole_dn": "manhole_999_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387894.296242429409176, 5866064.31225199252367 ], [ 1387918.333023339277133, 5866023.860149594023824 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_51_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_999_generated", "manhole_dn": "manhole_1000_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387918.333023339277133, 5866023.860149594023824 ], [ 1387925.576027213362977, 5865976.462517648003995 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_51_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 804.4000244140625, "invlev_up": 814.20001220703125, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1000_generated", "manhole_dn": "manhole_1001_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387925.576027213362977, 5865976.462517648003995 ], [ 1387926.166851800866425, 5865928.505292822606862 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_51_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1001_generated", "manhole_dn": "manhole_1002_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387926.166851800866425, 5865928.505292822606862 ], [ 1387922.175474973395467, 5865880.628693707287312 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_51_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1002_generated", "manhole_dn": "manhole_1003_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387922.175474973395467, 5865880.628693707287312 ], [ 1387918.184098146157339, 5865832.752094592899084 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_51_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 794.70001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_1003_generated", "manhole_dn": "manhole_1004_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387918.184098146157339, 5865832.752094592899084 ], [ 1387914.316889721900225, 5865784.868878290057182 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_51_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 792.20001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_1004_generated", "manhole_dn": "manhole_851_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387914.316889721900225, 5865784.868878290057182 ], [ 1387913.197226775344461, 5865736.839239663444459 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_52_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_52", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.4000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 815.9000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_983_generated", "manhole_dn": "manhole_1005_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388183.697466832818463, 5866137.747996928170323 ], [ 1388133.810787334572524, 5866135.250533932819963 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_52_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_52", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_1005_generated", "manhole_dn": "manhole_1006_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388133.810787334572524, 5866135.250533932819963 ], [ 1388083.924107836093754, 5866132.753070938400924 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "width": null, "bedlev": null, "branchid": "pipe_52_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_52", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 786.29998779296875, "invlev_up": 801.4000244140625, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_1006_generated", "manhole_dn": "manhole_992_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388083.924107836093754, 5866132.753070938400924 ], [ 1388034.037428337847814, 5866130.255607943050563 ] ] } } +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_1_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389238.298387300921604, 5860147.714495398104191 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 933.5, "invlev_up": 913.4000244140625, "invlev_dn": 931.0, "manhole_up": "manhole_1_generated", "manhole_dn": "manhole_2_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389238.298387300921604, 5860147.714495398104191 ], [ 1389210.947846550960094, 5860184.343885350972414 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.5, "elevtn_dn": 933.5, "invlev_up": 931.0, "invlev_dn": 931.0, "manhole_up": "manhole_2_generated", "manhole_dn": "manhole_3_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389210.947846550960094, 5860184.343885350972414 ], [ 1389186.961922727525234, 5860223.315261371433735 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.5, "elevtn_dn": 935.5, "invlev_up": 931.0, "invlev_dn": 933.0, "manhole_up": "manhole_3_generated", "manhole_dn": "manhole_4_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389186.961922727525234, 5860223.315261371433735 ], [ 1389162.755598766496405, 5860262.142883376218379 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 935.5, "invlev_up": 933.0, "invlev_dn": 933.0, "manhole_up": "manhole_4_generated", "manhole_dn": "manhole_5_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389162.755598766496405, 5860262.142883376218379 ], [ 1389136.759307563304901, 5860299.80301527120173 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 936.5, "invlev_up": 933.0, "invlev_dn": 934.0, "manhole_up": "manhole_5_generated", "manhole_dn": "manhole_6_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389136.759307563304901, 5860299.80301527120173 ], [ 1389109.7301227634307, 5860336.652257356792688 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 936.5, "elevtn_dn": 941.10003662109375, "invlev_up": 934.0, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_6_generated", "manhole_dn": "manhole_7_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389109.7301227634307, 5860336.652257356792688 ], [ 1389073.18478828552179, 5860363.522737024351954 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_7_generated", "manhole_dn": "manhole_8_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389073.18478828552179, 5860363.522737024351954 ], [ 1389032.546542100608349, 5860384.329287325032055 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_8_generated", "manhole_dn": "manhole_9_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389032.546542100608349, 5860384.329287325032055 ], [ 1388989.578410296700895, 5860400.071978960186243 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 951.29998779296875, "invlev_up": 938.60003662109375, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_9_generated", "manhole_dn": "manhole_10_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388989.578410296700895, 5860400.071978960186243 ], [ 1388946.301100668497384, 5860414.883977899327874 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_11_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389221.905703959986567, 5860123.3256367566064 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_11_generated", "manhole_dn": "manhole_12_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389221.905703959986567, 5860123.3256367566064 ], [ 1389177.295895804418251, 5860134.962970778346062 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 919.60003662109375, "invlev_up": 913.4000244140625, "invlev_dn": 917.10003662109375, "manhole_up": "manhole_12_generated", "manhole_dn": "manhole_13_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389177.295895804418251, 5860134.962970778346062 ], [ 1389132.686087648617104, 5860146.600304800085723 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 919.60003662109375, "elevtn_dn": 919.60003662109375, "invlev_up": 917.10003662109375, "invlev_dn": 917.10003662109375, "manhole_up": "manhole_13_generated", "manhole_dn": "manhole_14_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389132.686087648617104, 5860146.600304800085723 ], [ 1389088.076279493048787, 5860158.237638821825385 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 919.60003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 917.10003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_14_generated", "manhole_dn": "manhole_15_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389088.076279493048787, 5860158.237638821825385 ], [ 1389044.226173994829878, 5860172.143308508209884 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 935.60003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_15_generated", "manhole_dn": "manhole_16_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389044.226173994829878, 5860172.143308508209884 ], [ 1389012.527182487538084, 5860198.239755615592003 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 935.60003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_16_generated", "manhole_dn": "manhole_17_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389012.527182487538084, 5860198.239755615592003 ], [ 1388995.773122631013393, 5860240.481283166445792 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 945.0, "invlev_up": 935.60003662109375, "invlev_dn": 942.5, "manhole_up": "manhole_17_generated", "manhole_dn": "manhole_18_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388995.773122631013393, 5860240.481283166445792 ], [ 1388973.630034049740061, 5860280.918223639950156 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.0, "elevtn_dn": 951.29998779296875, "invlev_up": 942.5, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_18_generated", "manhole_dn": "manhole_19_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388973.630034049740061, 5860280.918223639950156 ], [ 1388961.171157888136804, 5860324.081192856654525 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_19_generated", "manhole_dn": "manhole_20_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388961.171157888136804, 5860324.081192856654525 ], [ 1388955.410555170848966, 5860369.690168970264494 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_20_generated", "manhole_dn": "manhole_10_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388955.410555170848966, 5860369.690168970264494 ], [ 1388946.301100668497384, 5860414.883977899327874 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 914.5, "invlev_up": 913.4000244140625, "invlev_dn": 912.0, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_21_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389306.50000010849908, 5860083.476415127515793 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 914.5, "elevtn_dn": 914.5, "invlev_up": 912.0, "invlev_dn": 912.0, "manhole_up": "manhole_21_generated", "manhole_dn": "manhole_22_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389306.50000010849908, 5860083.476415127515793 ], [ 1389355.420758404070511, 5860074.630405306816101 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 914.5, "elevtn_dn": 929.9000244140625, "invlev_up": 912.0, "invlev_dn": 927.4000244140625, "manhole_up": "manhole_22_generated", "manhole_dn": "manhole_23_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389355.420758404070511, 5860074.630405306816101 ], [ 1389389.090761042200029, 5860042.4449307853356 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 929.9000244140625, "elevtn_dn": 955.0, "invlev_up": 927.4000244140625, "invlev_dn": 952.5, "manhole_up": "manhole_23_generated", "manhole_dn": "manhole_24_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389389.090761042200029, 5860042.4449307853356 ], [ 1389404.036260401364416, 5859994.775433851405978 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_24_generated", "manhole_dn": "manhole_25_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389404.036260401364416, 5859994.775433851405978 ], [ 1389418.744130451697856, 5859947.032028519548476 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_25_generated", "manhole_dn": "manhole_26_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389418.744130451697856, 5859947.032028519548476 ], [ 1389423.265342897269875, 5859897.853969652205706 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 975.29998779296875, "invlev_up": 952.5, "invlev_dn": 972.79998779296875, "manhole_up": "manhole_26_generated", "manhole_dn": "manhole_27_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389423.265342897269875, 5859897.853969652205706 ], [ 1389395.831073811277747, 5859856.743154510855675 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 975.29998779296875, "elevtn_dn": 963.0, "invlev_up": 972.79998779296875, "invlev_dn": 960.5, "manhole_up": "manhole_27_generated", "manhole_dn": "manhole_28_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389395.831073811277747, 5859856.743154510855675 ], [ 1389350.827042841585353, 5859839.640478814020753 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 963.0, "elevtn_dn": 963.0, "invlev_up": 960.5, "invlev_dn": 960.5, "manhole_up": "manhole_28_generated", "manhole_dn": "manhole_29_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389350.827042841585353, 5859839.640478814020753 ], [ 1389303.795788601972163, 5859855.887689013034105 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 963.0, "elevtn_dn": 945.4000244140625, "invlev_up": 960.5, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_29_generated", "manhole_dn": "manhole_30_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389303.795788601972163, 5859855.887689013034105 ], [ 1389256.284586790716276, 5859863.631580747663975 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 945.4000244140625, "invlev_up": 942.9000244140625, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_30_generated", "manhole_dn": "manhole_31_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389256.284586790716276, 5859863.631580747663975 ], [ 1389227.308454349869862, 5859823.781623384915292 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 945.4000244140625, "invlev_up": 942.9000244140625, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_31_generated", "manhole_dn": "manhole_32_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389227.308454349869862, 5859823.781623384915292 ], [ 1389202.745489193825051, 5859780.279727600514889 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 959.10003662109375, "invlev_up": 942.9000244140625, "invlev_dn": 956.60003662109375, "manhole_up": "manhole_32_generated", "manhole_dn": "manhole_33_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389202.745489193825051, 5859780.279727600514889 ], [ 1389178.18252403778024, 5859736.777831817045808 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 959.10003662109375, "elevtn_dn": 944.79998779296875, "invlev_up": 956.60003662109375, "invlev_dn": 942.29998779296875, "manhole_up": "manhole_33_generated", "manhole_dn": "manhole_34_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389178.18252403778024, 5859736.777831817045808 ], [ 1389155.231297271326184, 5859692.450142606161535 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 944.79998779296875, "elevtn_dn": 944.79998779296875, "invlev_up": 942.29998779296875, "invlev_dn": 942.29998779296875, "manhole_up": "manhole_34_generated", "manhole_dn": "manhole_35_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389155.231297271326184, 5859692.450142606161535 ], [ 1389141.413412723457441, 5859644.883844587020576 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 944.79998779296875, "elevtn_dn": 952.4000244140625, "invlev_up": 942.29998779296875, "invlev_dn": 949.9000244140625, "manhole_up": "manhole_35_generated", "manhole_dn": "manhole_36_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389141.413412723457441, 5859644.883844587020576 ], [ 1389151.802280035568401, 5859598.61804121825844 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.4000244140625, "elevtn_dn": 960.70001220703125, "invlev_up": 949.9000244140625, "invlev_dn": 958.20001220703125, "manhole_up": "manhole_36_generated", "manhole_dn": "manhole_37_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389151.802280035568401, 5859598.61804121825844 ], [ 1389191.073854762827978, 5859569.046822287142277 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 960.70001220703125, "elevtn_dn": 960.70001220703125, "invlev_up": 958.20001220703125, "invlev_dn": 958.20001220703125, "manhole_up": "manhole_37_generated", "manhole_dn": "manhole_38_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389191.073854762827978, 5859569.046822287142277 ], [ 1389239.915165816899389, 5859563.955490378662944 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 960.70001220703125, "elevtn_dn": 969.60003662109375, "invlev_up": 958.20001220703125, "invlev_dn": 967.10003662109375, "manhole_up": "manhole_38_generated", "manhole_dn": "manhole_39_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389239.915165816899389, 5859563.955490378662944 ], [ 1389289.757686472963542, 5859566.285022127442062 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 969.60003662109375, "elevtn_dn": 969.60003662109375, "invlev_up": 967.10003662109375, "invlev_dn": 967.10003662109375, "manhole_up": "manhole_39_generated", "manhole_dn": "manhole_40_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389289.757686472963542, 5859566.285022127442062 ], [ 1389339.615828452631831, 5859566.079234052449465 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 969.60003662109375, "elevtn_dn": 976.29998779296875, "invlev_up": 967.10003662109375, "invlev_dn": 973.79998779296875, "manhole_up": "manhole_40_generated", "manhole_dn": "manhole_41_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389339.615828452631831, 5859566.079234052449465 ], [ 1389387.354307833593339, 5859551.676988741382957 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 976.29998779296875, "elevtn_dn": 976.29998779296875, "invlev_up": 973.79998779296875, "invlev_dn": 973.79998779296875, "manhole_up": "manhole_41_generated", "manhole_dn": "manhole_42_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389387.354307833593339, 5859551.676988741382957 ], [ 1389428.692968821851537, 5859524.248876142315567 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 976.29998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 973.79998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_42_generated", "manhole_dn": "manhole_43_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389428.692968821851537, 5859524.248876142315567 ], [ 1389461.138921525795013, 5859486.477508954703808 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_43_generated", "manhole_dn": "manhole_44_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389461.138921525795013, 5859486.477508954703808 ], [ 1389482.45163832209073, 5859441.487986368127167 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_44_generated", "manhole_dn": "manhole_45_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389482.45163832209073, 5859441.487986368127167 ], [ 1389497.215460168197751, 5859393.906833835877478 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_45_generated", "manhole_dn": "manhole_46_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389497.215460168197751, 5859393.906833835877478 ], [ 1389508.394423164660111, 5859345.216126504354179 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 954.79998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_46_generated", "manhole_dn": "manhole_47_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389508.394423164660111, 5859345.216126504354179 ], [ 1389518.522437864448875, 5859296.29671473056078 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 954.79998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_47_generated", "manhole_dn": "manhole_48_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389518.522437864448875, 5859296.29671473056078 ], [ 1389528.588071504374966, 5859247.363727764226496 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 950.20001220703125, "invlev_up": 954.79998779296875, "invlev_dn": 947.70001220703125, "manhole_up": "manhole_48_generated", "manhole_dn": "manhole_49_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389528.588071504374966, 5859247.363727764226496 ], [ 1389538.653705144301057, 5859198.43074079696089 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 950.20001220703125, "elevtn_dn": 957.60003662109375, "invlev_up": 947.70001220703125, "invlev_dn": 955.10003662109375, "manhole_up": "manhole_49_generated", "manhole_dn": "manhole_50_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389538.653705144301057, 5859198.43074079696089 ], [ 1389548.719338784459978, 5859149.497753830626607 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.60003662109375, "elevtn_dn": 957.60003662109375, "invlev_up": 955.10003662109375, "invlev_dn": 955.10003662109375, "manhole_up": "manhole_50_generated", "manhole_dn": "manhole_51_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389548.719338784459978, 5859149.497753830626607 ], [ 1389558.784972424386069, 5859100.564766863361001 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.60003662109375, "elevtn_dn": 954.79998779296875, "invlev_up": 955.10003662109375, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_51_generated", "manhole_dn": "manhole_52_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389558.784972424386069, 5859100.564766863361001 ], [ 1389568.85060606431216, 5859051.631779897026718 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 954.79998779296875, "invlev_up": 952.29998779296875, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_52_generated", "manhole_dn": "manhole_53_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389568.85060606431216, 5859051.631779897026718 ], [ 1389578.916239704471081, 5859002.698792929761112 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 954.79998779296875, "invlev_up": 952.29998779296875, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_53_generated", "manhole_dn": "manhole_54_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389578.916239704471081, 5859002.698792929761112 ], [ 1389588.981873344397172, 5858953.765805963426828 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 956.10003662109375, "invlev_up": 952.29998779296875, "invlev_dn": 953.60003662109375, "manhole_up": "manhole_54_generated", "manhole_dn": "manhole_55_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389588.981873344397172, 5858953.765805963426828 ], [ 1389599.047506984323263, 5858904.832818996161222 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 956.10003662109375, "elevtn_dn": 956.10003662109375, "invlev_up": 953.60003662109375, "invlev_dn": 953.60003662109375, "manhole_up": "manhole_55_generated", "manhole_dn": "manhole_56_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389599.047506984323263, 5858904.832818996161222 ], [ 1389613.243873829254881, 5858857.048414096236229 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 956.10003662109375, "elevtn_dn": 966.29998779296875, "invlev_up": 953.60003662109375, "invlev_dn": 963.79998779296875, "manhole_up": "manhole_56_generated", "manhole_dn": "manhole_57_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389613.243873829254881, 5858857.048414096236229 ], [ 1389631.198101107496768, 5858810.554778259247541 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 966.29998779296875, "elevtn_dn": 968.70001220703125, "invlev_up": 963.79998779296875, "invlev_dn": 966.20001220703125, "manhole_up": "manhole_57_generated", "manhole_dn": "manhole_58_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389631.198101107496768, 5858810.554778259247541 ], [ 1389656.490605737781152, 5858767.472956065088511 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.70001220703125, "elevtn_dn": 968.70001220703125, "invlev_up": 966.20001220703125, "invlev_dn": 966.20001220703125, "manhole_up": "manhole_58_generated", "manhole_dn": "manhole_59_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389656.490605737781152, 5858767.472956065088511 ], [ 1389681.956975018838421, 5858724.49639992788434 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.70001220703125, "elevtn_dn": 976.10003662109375, "invlev_up": 966.20001220703125, "invlev_dn": 973.60003662109375, "manhole_up": "manhole_59_generated", "manhole_dn": "manhole_60_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389681.956975018838421, 5858724.49639992788434 ], [ 1389708.407580326776952, 5858682.115747822448611 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 976.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 973.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_60_generated", "manhole_dn": "manhole_61_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389708.407580326776952, 5858682.115747822448611 ], [ 1389734.858185634715483, 5858639.735095717012882 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 980.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_61_generated", "manhole_dn": "manhole_62_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389734.858185634715483, 5858639.735095717012882 ], [ 1389761.308790942654014, 5858597.354443610645831 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 980.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_62_generated", "manhole_dn": "manhole_63_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389761.308790942654014, 5858597.354443610645831 ], [ 1389787.759396250825375, 5858554.973791505210102 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 993.29998779296875, "invlev_up": 980.60003662109375, "invlev_dn": 990.79998779296875, "manhole_up": "manhole_63_generated", "manhole_dn": "manhole_64_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389787.759396250825375, 5858554.973791505210102 ], [ 1389814.210001558763906, 5858512.593139399774373 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 993.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 990.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_64_generated", "manhole_dn": "manhole_65_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389814.210001558763906, 5858512.593139399774373 ], [ 1389840.660606866702437, 5858470.212487293407321 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 995.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_65_generated", "manhole_dn": "manhole_66_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389840.660606866702437, 5858470.212487293407321 ], [ 1389867.111212174640968, 5858427.831835187971592 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 995.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_66_generated", "manhole_dn": "manhole_67_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389867.111212174640968, 5858427.831835187971592 ], [ 1389911.240854029776528, 5858417.074701879173517 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 1006.2000122070312, "invlev_up": 995.79998779296875, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_67_generated", "manhole_dn": "manhole_68_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389911.240854029776528, 5858417.074701879173517 ], [ 1389940.226093058940023, 5858455.739661679603159 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E48", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1006.2000122070312, "invlev_up": 1003.7000122070312, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_68_generated", "manhole_dn": "manhole_69_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389940.226093058940023, 5858455.739661679603159 ], [ 1389959.842267287895083, 5858501.684845351614058 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E49", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1006.2000122070312, "invlev_up": 1003.7000122070312, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_69_generated", "manhole_dn": "manhole_70_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389959.842267287895083, 5858501.684845351614058 ], [ 1389983.028926897095516, 5858544.760824581608176 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E50", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1036.9000244140625, "invlev_up": 1003.7000122070312, "invlev_dn": 1034.4000244140625, "manhole_up": "manhole_70_generated", "manhole_dn": "manhole_71_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389983.028926897095516, 5858544.760824581608176 ], [ 1390026.879799408372492, 5858567.986969069577754 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E51", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1036.9000244140625, "elevtn_dn": 1036.9000244140625, "invlev_up": 1034.4000244140625, "invlev_dn": 1034.4000244140625, "manhole_up": "manhole_71_generated", "manhole_dn": "manhole_72_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390026.879799408372492, 5858567.986969069577754 ], [ 1390075.455719914287329, 5858577.981817713007331 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E52", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1036.9000244140625, "elevtn_dn": 1032.9000244140625, "invlev_up": 1034.4000244140625, "invlev_dn": 1030.4000244140625, "manhole_up": "manhole_72_generated", "manhole_dn": "manhole_73_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390075.455719914287329, 5858577.981817713007331 ], [ 1390124.934819511603564, 5858584.860858413390815 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E53", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1032.9000244140625, "elevtn_dn": 1032.9000244140625, "invlev_up": 1030.4000244140625, "invlev_dn": 1030.4000244140625, "manhole_up": "manhole_73_generated", "manhole_dn": "manhole_74_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390124.934819511603564, 5858584.860858413390815 ], [ 1390174.385966305155307, 5858591.894069475121796 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E54", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1032.9000244140625, "elevtn_dn": 1016.6000366210938, "invlev_up": 1030.4000244140625, "invlev_dn": 1014.1000366210938, "manhole_up": "manhole_74_generated", "manhole_dn": "manhole_75_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390174.385966305155307, 5858591.894069475121796 ], [ 1390224.28731826832518, 5858594.262458441779017 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E55", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1016.6000366210938, "elevtn_dn": 1016.6000366210938, "invlev_up": 1014.1000366210938, "invlev_dn": 1014.1000366210938, "manhole_up": "manhole_75_generated", "manhole_dn": "manhole_76_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390224.28731826832518, 5858594.262458441779017 ], [ 1390273.630285855382681, 5858589.561945637688041 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E56", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1016.6000366210938, "elevtn_dn": 1012.1000366210938, "invlev_up": 1014.1000366210938, "invlev_dn": 1009.6000366210938, "manhole_up": "manhole_76_generated", "manhole_dn": "manhole_77_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390273.630285855382681, 5858589.561945637688041 ], [ 1390322.239480242831632, 5858578.072306710295379 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E57", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1012.1000366210938, "elevtn_dn": 1012.1000366210938, "invlev_up": 1009.6000366210938, "invlev_dn": 1009.6000366210938, "manhole_up": "manhole_77_generated", "manhole_dn": "manhole_78_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390322.239480242831632, 5858578.072306710295379 ], [ 1390371.99352877959609, 5858575.309522898867726 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E58", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1012.1000366210938, "elevtn_dn": 1011.7000122070312, "invlev_up": 1009.6000366210938, "invlev_dn": 1009.2000122070312, "manhole_up": "manhole_78_generated", "manhole_dn": "manhole_79_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390371.99352877959609, 5858575.309522898867726 ], [ 1390419.13544210139662, 5858559.59311543405056 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E59", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1011.7000122070312, "elevtn_dn": 981.5, "invlev_up": 1009.2000122070312, "invlev_dn": 979.0, "manhole_up": "manhole_79_generated", "manhole_dn": "manhole_80_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390419.13544210139662, 5858559.59311543405056 ], [ 1390453.401623640675098, 5858524.246223840862513 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E60", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 981.5, "elevtn_dn": 995.70001220703125, "invlev_up": 979.0, "invlev_dn": 993.20001220703125, "manhole_up": "manhole_80_generated", "manhole_dn": "manhole_81_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390453.401623640675098, 5858524.246223840862513 ], [ 1390496.749499944737181, 5858504.780008735135198 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E61", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 995.70001220703125, "elevtn_dn": 995.70001220703125, "invlev_up": 993.20001220703125, "invlev_dn": 993.20001220703125, "manhole_up": "manhole_81_generated", "manhole_dn": "manhole_82_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390496.749499944737181, 5858504.780008735135198 ], [ 1390546.470755147282034, 5858499.993151630274951 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E62", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 995.70001220703125, "elevtn_dn": 1005.9000244140625, "invlev_up": 993.20001220703125, "invlev_dn": 1003.4000244140625, "manhole_up": "manhole_82_generated", "manhole_dn": "manhole_83_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390546.470755147282034, 5858499.993151630274951 ], [ 1390596.395264241611585, 5858498.177226040512323 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E63", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1005.9000244140625, "elevtn_dn": 1005.9000244140625, "invlev_up": 1003.4000244140625, "invlev_dn": 1003.4000244140625, "manhole_up": "manhole_83_generated", "manhole_dn": "manhole_84_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390596.395264241611585, 5858498.177226040512323 ], [ 1390646.319773336173967, 5858496.361300451681018 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E64", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1005.9000244140625, "elevtn_dn": 1013.6000366210938, "invlev_up": 1003.4000244140625, "invlev_dn": 1011.1000366210938, "manhole_up": "manhole_84_generated", "manhole_dn": "manhole_85_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390646.319773336173967, 5858496.361300451681018 ], [ 1390696.244282430503517, 5858494.545374862849712 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E65", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1013.6000366210938, "elevtn_dn": 1013.6000366210938, "invlev_up": 1011.1000366210938, "invlev_dn": 1011.1000366210938, "manhole_up": "manhole_85_generated", "manhole_dn": "manhole_86_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390696.244282430503517, 5858494.545374862849712 ], [ 1390746.168791524833068, 5858492.729449273087084 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E66", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1013.6000366210938, "elevtn_dn": 1019.1000366210938, "invlev_up": 1011.1000366210938, "invlev_dn": 1016.6000366210938, "manhole_up": "manhole_86_generated", "manhole_dn": "manhole_87_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390746.168791524833068, 5858492.729449273087084 ], [ 1390796.09330061939545, 5858490.913523684255779 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E67", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1019.1000366210938, "elevtn_dn": 1025.800048828125, "invlev_up": 1016.6000366210938, "invlev_dn": 1023.300048828125, "manhole_up": "manhole_87_generated", "manhole_dn": "manhole_88_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390796.09330061939545, 5858490.913523684255779 ], [ 1390846.017809713725001, 5858489.097598095424473 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E68", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1025.800048828125, "elevtn_dn": 1025.800048828125, "invlev_up": 1023.300048828125, "invlev_dn": 1023.300048828125, "manhole_up": "manhole_88_generated", "manhole_dn": "manhole_89_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390846.017809713725001, 5858489.097598095424473 ], [ 1390895.942318808054551, 5858487.281672505661845 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E69", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1025.800048828125, "elevtn_dn": 1029.2000732421875, "invlev_up": 1023.300048828125, "invlev_dn": 1026.7000732421875, "manhole_up": "manhole_89_generated", "manhole_dn": "manhole_90_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390895.942318808054551, 5858487.281672505661845 ], [ 1390945.364988021552563, 5858492.061225635930896 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E70", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1029.2000732421875, "elevtn_dn": 1029.2000732421875, "invlev_up": 1026.7000732421875, "invlev_dn": 1026.7000732421875, "manhole_up": "manhole_90_generated", "manhole_dn": "manhole_91_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390945.364988021552563, 5858492.061225635930896 ], [ 1390994.440001817885786, 5858501.409873396158218 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E71", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1029.2000732421875, "elevtn_dn": 1033.2000732421875, "invlev_up": 1026.7000732421875, "invlev_dn": 1030.7000732421875, "manhole_up": "manhole_91_generated", "manhole_dn": "manhole_92_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390994.440001817885786, 5858501.409873396158218 ], [ 1391040.341196772176772, 5858520.979841153137386 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E72", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1033.2000732421875, "elevtn_dn": 1033.2000732421875, "invlev_up": 1030.7000732421875, "invlev_dn": 1030.7000732421875, "manhole_up": "manhole_92_generated", "manhole_dn": "manhole_93_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391040.341196772176772, 5858520.979841153137386 ], [ 1391086.683747049886733, 5858538.717575071379542 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E73", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1033.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1030.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_93_generated", "manhole_dn": "manhole_94_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391086.683747049886733, 5858538.717575071379542 ], [ 1391131.822940095094964, 5858523.93243224080652 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E74", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_94_generated", "manhole_dn": "manhole_95_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391131.822940095094964, 5858523.93243224080652 ], [ 1391153.157672074623406, 5858479.460670891217887 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E75", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_95_generated", "manhole_dn": "manhole_96_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391153.157672074623406, 5858479.460670891217887 ], [ 1391192.49590603238903, 5858451.67839205916971 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E76", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1044.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1041.7000732421875, "manhole_up": "manhole_96_generated", "manhole_dn": "manhole_97_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391192.49590603238903, 5858451.67839205916971 ], [ 1391240.64117361814715, 5858438.460245226509869 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E77", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1044.2000732421875, "elevtn_dn": 1044.2000732421875, "invlev_up": 1041.7000732421875, "invlev_dn": 1041.7000732421875, "manhole_up": "manhole_97_generated", "manhole_dn": "manhole_98_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391240.64117361814715, 5858438.460245226509869 ], [ 1391289.211760010803118, 5858426.770406410098076 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E78", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1044.2000732421875, "elevtn_dn": 1060.0999755859375, "invlev_up": 1041.7000732421875, "invlev_dn": 1057.5999755859375, "manhole_up": "manhole_98_generated", "manhole_dn": "manhole_99_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391289.211760010803118, 5858426.770406410098076 ], [ 1391337.782346403226256, 5858415.080567593686283 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E79", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1060.0999755859375, "elevtn_dn": 1023.0, "invlev_up": 1057.5999755859375, "invlev_dn": 1020.5, "manhole_up": "manhole_99_generated", "manhole_dn": "manhole_100_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391337.782346403226256, 5858415.080567593686283 ], [ 1391386.352932795882225, 5858403.390728777274489 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E80", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1023.0, "elevtn_dn": 1032.7000732421875, "invlev_up": 1020.5, "invlev_dn": 1030.2000732421875, "manhole_up": "manhole_100_generated", "manhole_dn": "manhole_101_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391386.352932795882225, 5858403.390728777274489 ], [ 1391434.923519188305363, 5858391.700889961794019 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E81", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1032.7000732421875, "elevtn_dn": 1032.7000732421875, "invlev_up": 1030.2000732421875, "invlev_dn": 1030.2000732421875, "manhole_up": "manhole_101_generated", "manhole_dn": "manhole_102_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391434.923519188305363, 5858391.700889961794019 ], [ 1391483.494105580961332, 5858380.011051145382226 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E82", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1032.7000732421875, "elevtn_dn": 1040.7000732421875, "invlev_up": 1030.2000732421875, "invlev_dn": 1038.2000732421875, "manhole_up": "manhole_102_generated", "manhole_dn": "manhole_103_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391483.494105580961332, 5858380.011051145382226 ], [ 1391532.464345134794712, 5858375.802092345431447 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E83", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1040.7000732421875, "elevtn_dn": 1040.7000732421875, "invlev_up": 1038.2000732421875, "invlev_dn": 1038.2000732421875, "manhole_up": "manhole_103_generated", "manhole_dn": "manhole_104_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391532.464345134794712, 5858375.802092345431447 ], [ 1391579.680508555145934, 5858389.753166117705405 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E84", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1040.7000732421875, "elevtn_dn": 1094.5999755859375, "invlev_up": 1038.2000732421875, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_104_generated", "manhole_dn": "manhole_105_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391579.680508555145934, 5858389.753166117705405 ], [ 1391615.043221722124144, 5858422.374543751589954 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E85", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1094.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_105_generated", "manhole_dn": "manhole_106_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391615.043221722124144, 5858422.374543751589954 ], [ 1391633.654095822479576, 5858468.206737855449319 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E86", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1094.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_106_generated", "manhole_dn": "manhole_107_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391633.654095822479576, 5858468.206737855449319 ], [ 1391675.556871910346672, 5858492.042518986389041 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E87", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1100.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1098.0999755859375, "manhole_up": "manhole_107_generated", "manhole_dn": "manhole_108_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391675.556871910346672, 5858492.042518986389041 ], [ 1391725.165284683462232, 5858493.223410680890083 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E88", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1100.5999755859375, "elevtn_dn": 1092.7000732421875, "invlev_up": 1098.0999755859375, "invlev_dn": 1090.2000732421875, "manhole_up": "manhole_108_generated", "manhole_dn": "manhole_109_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391725.165284683462232, 5858493.223410680890083 ], [ 1391774.025632579578087, 5858482.968163449317217 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E89", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1092.7000732421875, "elevtn_dn": 1092.7000732421875, "invlev_up": 1090.2000732421875, "invlev_dn": 1090.2000732421875, "manhole_up": "manhole_109_generated", "manhole_dn": "manhole_110_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391774.025632579578087, 5858482.968163449317217 ], [ 1391822.748904443578795, 5858472.800456050783396 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E90", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1092.7000732421875, "elevtn_dn": 1086.5, "invlev_up": 1090.2000732421875, "invlev_dn": 1084.0, "manhole_up": "manhole_110_generated", "manhole_dn": "manhole_111_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391822.748904443578795, 5858472.800456050783396 ], [ 1391872.520155652426183, 5858474.254766616038978 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E91", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1086.5, "elevtn_dn": 1086.5, "invlev_up": 1084.0, "invlev_dn": 1084.0, "manhole_up": "manhole_111_generated", "manhole_dn": "manhole_112_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391872.520155652426183, 5858474.254766616038978 ], [ 1391922.32820742437616, 5858478.116394865326583 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E92", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1086.5, "elevtn_dn": 1097.300048828125, "invlev_up": 1084.0, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_112_generated", "manhole_dn": "manhole_113_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391922.32820742437616, 5858478.116394865326583 ], [ 1391972.136259196558967, 5858481.978023114614189 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E93", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_113_generated", "manhole_dn": "manhole_114_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391972.136259196558967, 5858481.978023114614189 ], [ 1392014.088137687649578, 5858507.265420926734805 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E94", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_114_generated", "manhole_dn": "manhole_115_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392014.088137687649578, 5858507.265420926734805 ], [ 1392052.00577615830116, 5858538.949620860628784 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E95", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_115_generated", "manhole_dn": "manhole_116_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392052.00577615830116, 5858538.949620860628784 ], [ 1392100.993319420609623, 5858548.746293722651899 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E96", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1135.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1132.800048828125, "manhole_up": "manhole_116_generated", "manhole_dn": "manhole_117_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392100.993319420609623, 5858548.746293722651899 ], [ 1392149.980862683150917, 5858558.542966585606337 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E97", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1135.300048828125, "elevtn_dn": 1135.300048828125, "invlev_up": 1132.800048828125, "invlev_dn": 1132.800048828125, "manhole_up": "manhole_117_generated", "manhole_dn": "manhole_118_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392149.980862683150917, 5858558.542966585606337 ], [ 1392198.767287699971348, 5858569.25206732749939 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E98", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1135.300048828125, "elevtn_dn": 1137.5999755859375, "invlev_up": 1132.800048828125, "invlev_dn": 1135.0999755859375, "manhole_up": "manhole_118_generated", "manhole_dn": "manhole_119_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392198.767287699971348, 5858569.25206732749939 ], [ 1392247.333906656363979, 5858580.958378325216472 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E99", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1137.5999755859375, "elevtn_dn": 1137.5999755859375, "invlev_up": 1135.0999755859375, "invlev_dn": 1135.0999755859375, "manhole_up": "manhole_119_generated", "manhole_dn": "manhole_120_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392247.333906656363979, 5858580.958378325216472 ], [ 1392295.900525612989441, 5858592.664689323864877 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E100", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1137.5999755859375, "elevtn_dn": 1145.0999755859375, "invlev_up": 1135.0999755859375, "invlev_dn": 1142.5999755859375, "manhole_up": "manhole_120_generated", "manhole_dn": "manhole_121_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392295.900525612989441, 5858592.664689323864877 ], [ 1392344.467144569614902, 5858604.371000322513282 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E101", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1145.0999755859375, "elevtn_dn": 1145.0999755859375, "invlev_up": 1142.5999755859375, "invlev_dn": 1142.5999755859375, "manhole_up": "manhole_121_generated", "manhole_dn": "manhole_122_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392344.467144569614902, 5858604.371000322513282 ], [ 1392389.908255772199482, 5858624.575613909401 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E102", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1145.0999755859375, "elevtn_dn": 1140.5, "invlev_up": 1142.5999755859375, "invlev_dn": 1138.0, "manhole_up": "manhole_122_generated", "manhole_dn": "manhole_123_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392389.908255772199482, 5858624.575613909401 ], [ 1392425.081700494978577, 5858659.315580372698605 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E103", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1140.5, "elevtn_dn": 1169.300048828125, "invlev_up": 1138.0, "invlev_dn": 1166.800048828125, "manhole_up": "manhole_123_generated", "manhole_dn": "manhole_124_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392425.081700494978577, 5858659.315580372698605 ], [ 1392458.203119478421286, 5858696.715123130939901 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E104", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.300048828125, "elevtn_dn": 1169.300048828125, "invlev_up": 1166.800048828125, "invlev_dn": 1166.800048828125, "manhole_up": "manhole_124_generated", "manhole_dn": "manhole_125_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392458.203119478421286, 5858696.715123130939901 ], [ 1392491.324538461863995, 5858734.114665890112519 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E105", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.300048828125, "elevtn_dn": 1165.5, "invlev_up": 1166.800048828125, "invlev_dn": 1163.0, "manhole_up": "manhole_125_generated", "manhole_dn": "manhole_126_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392491.324538461863995, 5858734.114665890112519 ], [ 1392528.963966277893633, 5858766.460637149401009 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E106", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1165.5, "elevtn_dn": 1165.5, "invlev_up": 1163.0, "invlev_dn": 1163.0, "manhole_up": "manhole_126_generated", "manhole_dn": "manhole_127_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392528.963966277893633, 5858766.460637149401009 ], [ 1392573.284122244687751, 5858789.391092935577035 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E107", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1165.5, "elevtn_dn": 1157.0999755859375, "invlev_up": 1163.0, "invlev_dn": 1154.5999755859375, "manhole_up": "manhole_127_generated", "manhole_dn": "manhole_128_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392573.284122244687751, 5858789.391092935577035 ], [ 1392618.033192394766957, 5858811.600886153057218 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E108", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1157.0999755859375, "elevtn_dn": 1184.800048828125, "invlev_up": 1154.5999755859375, "invlev_dn": 1182.300048828125, "manhole_up": "manhole_128_generated", "manhole_dn": "manhole_129_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392618.033192394766957, 5858811.600886153057218 ], [ 1392666.730896146036685, 5858821.011833874508739 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E109", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1184.800048828125, "elevtn_dn": 1141.2000732421875, "invlev_up": 1182.300048828125, "invlev_dn": 1138.7000732421875, "manhole_up": "manhole_129_generated", "manhole_dn": "manhole_130_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392666.730896146036685, 5858821.011833874508739 ], [ 1392714.397227015113458, 5858809.184477739967406 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E110", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1141.2000732421875, "elevtn_dn": 1141.2000732421875, "invlev_up": 1138.7000732421875, "invlev_dn": 1138.7000732421875, "manhole_up": "manhole_130_generated", "manhole_dn": "manhole_131_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392714.397227015113458, 5858809.184477739967406 ], [ 1392761.799294820055366, 5858794.231293976306915 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E111", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1141.2000732421875, "elevtn_dn": 1137.4000244140625, "invlev_up": 1138.7000732421875, "invlev_dn": 1134.9000244140625, "manhole_up": "manhole_131_generated", "manhole_dn": "manhole_132_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392761.799294820055366, 5858794.231293976306915 ], [ 1392810.095712865469977, 5858797.830352782271802 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E112", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1137.4000244140625, "elevtn_dn": 1137.4000244140625, "invlev_up": 1134.9000244140625, "invlev_dn": 1134.9000244140625, "manhole_up": "manhole_132_generated", "manhole_dn": "manhole_133_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392810.095712865469977, 5858797.830352782271802 ], [ 1392855.660074200481176, 5858817.529770986177027 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E113", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1137.4000244140625, "elevtn_dn": 1169.5, "invlev_up": 1134.9000244140625, "invlev_dn": 1167.0, "manhole_up": "manhole_133_generated", "manhole_dn": "manhole_134_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392855.660074200481176, 5858817.529770986177027 ], [ 1392904.672455, 5858826.347064822912216 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E114", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_134_generated", "manhole_dn": "manhole_135_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392904.672455, 5858826.347064822912216 ], [ 1392949.505032581742853, 5858846.393358059227467 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E115", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_135_generated", "manhole_dn": "manhole_136_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392949.505032581742853, 5858846.393358059227467 ], [ 1392993.956312821945176, 5858868.358838438987732 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E116", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_136_generated", "manhole_dn": "manhole_137_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392993.956312821945176, 5858868.358838438987732 ], [ 1393042.160067020915449, 5858881.479519641026855 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E117", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1162.0, "invlev_up": 1167.0, "invlev_dn": 1159.5, "manhole_up": "manhole_137_generated", "manhole_dn": "manhole_138_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393042.160067020915449, 5858881.479519641026855 ], [ 1393090.363821219652891, 5858894.600200843065977 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E118", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1162.0, "elevtn_dn": 1162.0, "invlev_up": 1159.5, "invlev_dn": 1159.5, "manhole_up": "manhole_138_generated", "manhole_dn": "manhole_139_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393090.363821219652891, 5858894.600200843065977 ], [ 1393138.877780271228403, 5858905.382868006825447 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E119", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1162.0, "elevtn_dn": 1152.0999755859375, "invlev_up": 1159.5, "invlev_dn": 1149.5999755859375, "manhole_up": "manhole_139_generated", "manhole_dn": "manhole_140_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393138.877780271228403, 5858905.382868006825447 ], [ 1393188.835210436256602, 5858905.286093098111451 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E120", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1152.0999755859375, "elevtn_dn": 1152.0999755859375, "invlev_up": 1149.5999755859375, "invlev_dn": 1149.5999755859375, "manhole_up": "manhole_140_generated", "manhole_dn": "manhole_141_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393188.835210436256602, 5858905.286093098111451 ], [ 1393237.248238409170881, 5858916.599204055964947 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E121", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1152.0999755859375, "elevtn_dn": 1147.300048828125, "invlev_up": 1149.5999755859375, "invlev_dn": 1144.800048828125, "manhole_up": "manhole_141_generated", "manhole_dn": "manhole_142_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393237.248238409170881, 5858916.599204055964947 ], [ 1393278.15638761385344, 5858943.766047672368586 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E122", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1147.300048828125, "elevtn_dn": 1182.7000732421875, "invlev_up": 1144.800048828125, "invlev_dn": 1180.2000732421875, "manhole_up": "manhole_142_generated", "manhole_dn": "manhole_143_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393278.15638761385344, 5858943.766047672368586 ], [ 1393316.553906054003164, 5858975.725158606655896 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E123", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1182.7000732421875, "elevtn_dn": 1180.0999755859375, "invlev_up": 1180.2000732421875, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_143_generated", "manhole_dn": "manhole_144_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393316.553906054003164, 5858975.725158606655896 ], [ 1393354.951424494385719, 5859007.684269540011883 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E124", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1180.0999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_144_generated", "manhole_dn": "manhole_145_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393354.951424494385719, 5859007.684269540011883 ], [ 1393393.348942934535444, 5859039.643380474299192 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E125", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1180.0999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_145_generated", "manhole_dn": "manhole_146_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393393.348942934535444, 5859039.643380474299192 ], [ 1393431.746461374685168, 5859071.602491408586502 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E126", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_146_generated", "manhole_dn": "manhole_147_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393431.746461374685168, 5859071.602491408586502 ], [ 1393472.672340910183266, 5859100.089053857140243 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E127", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1200.0999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_147_generated", "manhole_dn": "manhole_148_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393472.672340910183266, 5859100.089053857140243 ], [ 1393507.678647378925234, 5859134.262682756409049 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E128", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1200.0999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_148_generated", "manhole_dn": "manhole_149_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393507.678647378925234, 5859134.262682756409049 ], [ 1393492.637579936999828, 5859179.667013085447252 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E129", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1232.300048828125, "invlev_up": 1200.0999755859375, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_149_generated", "manhole_dn": "manhole_150_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393492.637579936999828, 5859179.667013085447252 ], [ 1393472.727902054553851, 5859225.064155456610024 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E130", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_150_generated", "manhole_dn": "manhole_151_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393472.727902054553851, 5859225.064155456610024 ], [ 1393467.563765458529815, 5859274.587596206925809 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E131", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_151_generated", "manhole_dn": "manhole_152_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393467.563765458529815, 5859274.587596206925809 ], [ 1393473.51405850565061, 5859323.8850102070719 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E132", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_152_generated", "manhole_dn": "manhole_153_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393473.51405850565061, 5859323.8850102070719 ], [ 1393507.773820924572647, 5859356.614802500233054 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E133", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1214.800048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1212.300048828125, "manhole_up": "manhole_153_generated", "manhole_dn": "manhole_154_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393507.773820924572647, 5859356.614802500233054 ], [ 1393555.824224345618859, 5859349.253152369521558 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E134", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1214.800048828125, "elevtn_dn": 1214.800048828125, "invlev_up": 1212.300048828125, "invlev_dn": 1212.300048828125, "manhole_up": "manhole_154_generated", "manhole_dn": "manhole_155_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393555.824224345618859, 5859349.253152369521558 ], [ 1393591.00338595919311, 5859314.794959847815335 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E135", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1214.800048828125, "elevtn_dn": 1191.0999755859375, "invlev_up": 1212.300048828125, "invlev_dn": 1188.5999755859375, "manhole_up": "manhole_155_generated", "manhole_dn": "manhole_156_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393591.00338595919311, 5859314.794959847815335 ], [ 1393633.153639519121498, 5859288.066565420478582 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E136", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1191.0999755859375, "elevtn_dn": 1191.0999755859375, "invlev_up": 1188.5999755859375, "invlev_dn": 1188.5999755859375, "manhole_up": "manhole_156_generated", "manhole_dn": "manhole_157_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393633.153639519121498, 5859288.066565420478582 ], [ 1393673.123904188396409, 5859258.097712650895119 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E137", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1191.0999755859375, "elevtn_dn": 1144.300048828125, "invlev_up": 1188.5999755859375, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_157_generated", "manhole_dn": "manhole_158_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393673.123904188396409, 5859258.097712650895119 ], [ 1393720.523227575467899, 5859244.838272913359106 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E138", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1144.300048828125, "invlev_up": 1141.800048828125, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_158_generated", "manhole_dn": "manhole_159_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393720.523227575467899, 5859244.838272913359106 ], [ 1393765.710014625452459, 5859224.569284616038203 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E139", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1144.300048828125, "invlev_up": 1141.800048828125, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_159_generated", "manhole_dn": "manhole_160_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393765.710014625452459, 5859224.569284616038203 ], [ 1393806.409210936399177, 5859195.609256223775446 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E140", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1112.5, "invlev_up": 1141.800048828125, "invlev_dn": 1110.0, "manhole_up": "manhole_160_generated", "manhole_dn": "manhole_161_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393806.409210936399177, 5859195.609256223775446 ], [ 1393846.866742686368525, 5859166.301538489758968 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1045", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 968.29998779296875, "invlev_up": 965.79998779296875, "invlev_dn": 965.79998779296875, "manhole_up": "manhole_162_generated", "manhole_dn": "manhole_163_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388521.257592596346512, 5855362.027613477781415 ], [ 1388472.030306826578453, 5855370.543775821104646 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1046", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 968.29998779296875, "invlev_up": 965.79998779296875, "invlev_dn": 965.79998779296875, "manhole_up": "manhole_163_generated", "manhole_dn": "manhole_164_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388472.030306826578453, 5855370.543775821104646 ], [ 1388439.000347282737494, 5855407.802592809312046 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1047", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 964.5, "invlev_up": 965.79998779296875, "invlev_dn": 962.0, "manhole_up": "manhole_164_generated", "manhole_dn": "manhole_165_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388439.000347282737494, 5855407.802592809312046 ], [ 1388400.196091859601438, 5855436.014134516008198 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1048", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 964.5, "invlev_up": 962.0, "invlev_dn": 962.0, "manhole_up": "manhole_165_generated", "manhole_dn": "manhole_166_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388400.196091859601438, 5855436.014134516008198 ], [ 1388351.33823574683629, 5855446.634319253265858 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1049", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 981.9000244140625, "invlev_up": 962.0, "invlev_dn": 979.4000244140625, "manhole_up": "manhole_166_generated", "manhole_dn": "manhole_167_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388351.33823574683629, 5855446.634319253265858 ], [ 1388301.961881892289966, 5855453.847477887757123 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1050", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 981.9000244140625, "elevtn_dn": 981.9000244140625, "invlev_up": 979.4000244140625, "invlev_dn": 979.4000244140625, "manhole_up": "manhole_167_generated", "manhole_dn": "manhole_168_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388301.961881892289966, 5855453.847477887757123 ], [ 1388252.297577269142494, 5855451.260453455150127 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1051", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 981.9000244140625, "elevtn_dn": 973.70001220703125, "invlev_up": 979.4000244140625, "invlev_dn": 971.20001220703125, "manhole_up": "manhole_168_generated", "manhole_dn": "manhole_169_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388252.297577269142494, 5855451.260453455150127 ], [ 1388202.479659734526649, 5855455.508814659900963 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1052", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 973.70001220703125, "elevtn_dn": 961.70001220703125, "invlev_up": 971.20001220703125, "invlev_dn": 959.20001220703125, "manhole_up": "manhole_169_generated", "manhole_dn": "manhole_170_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388202.479659734526649, 5855455.508814659900963 ], [ 1388152.683455461403355, 5855460.015516467392445 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1053", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 961.70001220703125, "elevtn_dn": 961.70001220703125, "invlev_up": 959.20001220703125, "invlev_dn": 959.20001220703125, "manhole_up": "manhole_170_generated", "manhole_dn": "manhole_171_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388152.683455461403355, 5855460.015516467392445 ], [ 1388104.622611842118204, 5855473.253733876161277 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1054", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 961.70001220703125, "elevtn_dn": 945.79998779296875, "invlev_up": 959.20001220703125, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_171_generated", "manhole_dn": "manhole_172_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388104.622611842118204, 5855473.253733876161277 ], [ 1388057.00563437351957, 5855488.445189393125474 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1055", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 945.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_172_generated", "manhole_dn": "manhole_173_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388057.00563437351957, 5855488.445189393125474 ], [ 1388011.292356542311609, 5855508.700276436284184 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1056", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 945.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_173_generated", "manhole_dn": "manhole_174_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388011.292356542311609, 5855508.700276436284184 ], [ 1387969.221702651120722, 5855535.246164590120316 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1057", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 930.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 928.29998779296875, "manhole_up": "manhole_174_generated", "manhole_dn": "manhole_175_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.221702651120722, 5855535.246164590120316 ], [ 1387935.863196024205536, 5855572.491061648353934 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1058", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 930.79998779296875, "elevtn_dn": 957.10003662109375, "invlev_up": 928.29998779296875, "invlev_dn": 954.60003662109375, "manhole_up": "manhole_175_generated", "manhole_dn": "manhole_176_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387935.863196024205536, 5855572.491061648353934 ], [ 1387904.610231971368194, 5855611.432584651745856 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1059", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.10003662109375, "elevtn_dn": 947.4000244140625, "invlev_up": 954.60003662109375, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_176_generated", "manhole_dn": "manhole_177_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387904.610231971368194, 5855611.432584651745856 ], [ 1387869.335365027422085, 5855646.852918352000415 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1060", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 947.4000244140625, "invlev_up": 944.9000244140625, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_177_generated", "manhole_dn": "manhole_178_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387869.335365027422085, 5855646.852918352000415 ], [ 1387831.783288773847744, 5855679.735664095729589 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1061", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 947.4000244140625, "invlev_up": 944.9000244140625, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_178_generated", "manhole_dn": "manhole_179_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387831.783288773847744, 5855679.735664095729589 ], [ 1387791.509416193468496, 5855708.923279576934874 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1062", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 933.29998779296875, "invlev_up": 944.9000244140625, "invlev_dn": 930.79998779296875, "manhole_up": "manhole_179_generated", "manhole_dn": "manhole_180_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387791.509416193468496, 5855708.923279576934874 ], [ 1387742.459816947113723, 5855717.213657722808421 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1063", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.29998779296875, "elevtn_dn": 933.29998779296875, "invlev_up": 930.79998779296875, "invlev_dn": 930.79998779296875, "manhole_up": "manhole_180_generated", "manhole_dn": "manhole_181_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387742.459816947113723, 5855717.213657722808421 ], [ 1387692.500367184402421, 5855718.495403698645532 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1064", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.29998779296875, "elevtn_dn": 911.10003662109375, "invlev_up": 930.79998779296875, "invlev_dn": 908.60003662109375, "manhole_up": "manhole_181_generated", "manhole_dn": "manhole_182_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387692.500367184402421, 5855718.495403698645532 ], [ 1387642.500798417022452, 5855718.61967874225229 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1065", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.10003662109375, "elevtn_dn": 887.70001220703125, "invlev_up": 908.60003662109375, "invlev_dn": 885.20001220703125, "manhole_up": "manhole_182_generated", "manhole_dn": "manhole_183_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387642.500798417022452, 5855718.61967874225229 ], [ 1387592.501229649642482, 5855718.743953784927726 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1066", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 887.70001220703125, "elevtn_dn": 887.70001220703125, "invlev_up": 885.20001220703125, "invlev_dn": 885.20001220703125, "manhole_up": "manhole_183_generated", "manhole_dn": "manhole_184_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387592.501229649642482, 5855718.743953784927726 ], [ 1387542.501660882262513, 5855718.868228827603161 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1067", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 887.70001220703125, "elevtn_dn": 902.9000244140625, "invlev_up": 885.20001220703125, "invlev_dn": 900.4000244140625, "manhole_up": "manhole_184_generated", "manhole_dn": "manhole_185_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387542.501660882262513, 5855718.868228827603161 ], [ 1387492.651409652316943, 5855720.815255363471806 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1068", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 902.9000244140625, "elevtn_dn": 902.9000244140625, "invlev_up": 900.4000244140625, "invlev_dn": 900.4000244140625, "manhole_up": "manhole_185_generated", "manhole_dn": "manhole_186_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387492.651409652316943, 5855720.815255363471806 ], [ 1387448.867236748570576, 5855742.752516686916351 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1069", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 902.9000244140625, "elevtn_dn": 886.20001220703125, "invlev_up": 900.4000244140625, "invlev_dn": 883.70001220703125, "manhole_up": "manhole_186_generated", "manhole_dn": "manhole_187_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387448.867236748570576, 5855742.752516686916351 ], [ 1387402.432745414320379, 5855761.091833713464439 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1070", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 886.20001220703125, "elevtn_dn": 886.20001220703125, "invlev_up": 883.70001220703125, "invlev_dn": 883.70001220703125, "manhole_up": "manhole_187_generated", "manhole_dn": "manhole_188_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387402.432745414320379, 5855761.091833713464439 ], [ 1387355.687973388005048, 5855778.837216476909816 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1071", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 886.20001220703125, "elevtn_dn": 879.4000244140625, "invlev_up": 883.70001220703125, "invlev_dn": 876.9000244140625, "manhole_up": "manhole_188_generated", "manhole_dn": "manhole_189_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387355.687973388005048, 5855778.837216476909816 ], [ 1387308.943201361689717, 5855796.582599240355194 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1072", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 879.4000244140625, "elevtn_dn": 879.4000244140625, "invlev_up": 876.9000244140625, "invlev_dn": 876.9000244140625, "manhole_up": "manhole_189_generated", "manhole_dn": "manhole_190_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387308.943201361689717, 5855796.582599240355194 ], [ 1387262.861613623332232, 5855815.656713440082967 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1073", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 879.4000244140625, "elevtn_dn": 873.29998779296875, "invlev_up": 876.9000244140625, "invlev_dn": 870.79998779296875, "manhole_up": "manhole_190_generated", "manhole_dn": "manhole_191_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387262.861613623332232, 5855815.656713440082967 ], [ 1387224.059019178850576, 5855846.996291697025299 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1074", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 873.29998779296875, "elevtn_dn": 938.9000244140625, "invlev_up": 870.79998779296875, "invlev_dn": 936.4000244140625, "manhole_up": "manhole_191_generated", "manhole_dn": "manhole_192_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387224.059019178850576, 5855846.996291697025299 ], [ 1387180.719124856637791, 5855870.194651792757213 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1075", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 938.9000244140625, "elevtn_dn": 932.79998779296875, "invlev_up": 936.4000244140625, "invlev_dn": 930.29998779296875, "manhole_up": "manhole_192_generated", "manhole_dn": "manhole_193_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387180.719124856637791, 5855870.194651792757213 ], [ 1387131.003996425773948, 5855874.064550469629467 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1076", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.79998779296875, "elevtn_dn": 932.79998779296875, "invlev_up": 930.29998779296875, "invlev_dn": 930.29998779296875, "manhole_up": "manhole_193_generated", "manhole_dn": "manhole_194_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387131.003996425773948, 5855874.064550469629467 ], [ 1387081.098878284916282, 5855871.158613862469792 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1077", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.79998779296875, "elevtn_dn": 916.79998779296875, "invlev_up": 930.29998779296875, "invlev_dn": 914.29998779296875, "manhole_up": "manhole_194_generated", "manhole_dn": "manhole_195_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387081.098878284916282, 5855871.158613862469792 ], [ 1387031.198060098802671, 5855868.015261265449226 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1078", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 916.79998779296875, "elevtn_dn": 916.79998779296875, "invlev_up": 914.29998779296875, "invlev_dn": 914.29998779296875, "manhole_up": "manhole_195_generated", "manhole_dn": "manhole_196_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387031.198060098802671, 5855868.015261265449226 ], [ 1386981.297241912456229, 5855864.871908667497337 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1079", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 916.79998779296875, "elevtn_dn": 891.79998779296875, "invlev_up": 914.29998779296875, "invlev_dn": 889.29998779296875, "manhole_up": "manhole_196_generated", "manhole_dn": "manhole_197_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386981.297241912456229, 5855864.871908667497337 ], [ 1386931.47147326474078, 5855860.718019699677825 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1080", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.79998779296875, "elevtn_dn": 891.79998779296875, "invlev_up": 889.29998779296875, "invlev_dn": 889.29998779296875, "manhole_up": "manhole_197_generated", "manhole_dn": "manhole_198_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386931.47147326474078, 5855860.718019699677825 ], [ 1386881.600663758814335, 5855857.577047945931554 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1081", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.79998779296875, "elevtn_dn": 857.10003662109375, "invlev_up": 889.29998779296875, "invlev_dn": 854.60003662109375, "manhole_up": "manhole_198_generated", "manhole_dn": "manhole_199_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386881.600663758814335, 5855857.577047945931554 ], [ 1386832.545593914575875, 5855864.100992278195918 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1082", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 857.10003662109375, "elevtn_dn": 857.10003662109375, "invlev_up": 854.60003662109375, "invlev_dn": 854.60003662109375, "manhole_up": "manhole_199_generated", "manhole_dn": "manhole_200_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386832.545593914575875, 5855864.100992278195918 ], [ 1386787.06764860637486, 5855884.403254445642233 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1083", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 857.10003662109375, "elevtn_dn": 821.29998779296875, "invlev_up": 854.60003662109375, "invlev_dn": 818.79998779296875, "manhole_up": "manhole_200_generated", "manhole_dn": "manhole_201_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386787.06764860637486, 5855884.403254445642233 ], [ 1386748.278358669718727, 5855915.544586268253624 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1084", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 821.29998779296875, "elevtn_dn": 821.29998779296875, "invlev_up": 818.79998779296875, "invlev_dn": 818.79998779296875, "manhole_up": "manhole_201_generated", "manhole_dn": "manhole_202_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386748.278358669718727, 5855915.544586268253624 ], [ 1386721.155419877264649, 5855957.124278785660863 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1085", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 821.29998779296875, "elevtn_dn": 866.0, "invlev_up": 818.79998779296875, "invlev_dn": 863.5, "manhole_up": "manhole_202_generated", "manhole_dn": "manhole_203_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386721.155419877264649, 5855957.124278785660863 ], [ 1386707.750365849817172, 5856004.850832763127983 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1086", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 866.0, "invlev_up": 863.5, "invlev_dn": 863.5, "manhole_up": "manhole_203_generated", "manhole_dn": "manhole_204_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386707.750365849817172, 5856004.850832763127983 ], [ 1386699.832475832896307, 5856054.133603978902102 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1087", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 866.0, "invlev_up": 863.5, "invlev_dn": 863.5, "manhole_up": "manhole_204_generated", "manhole_dn": "manhole_205_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386699.832475832896307, 5856054.133603978902102 ], [ 1386697.095561265014112, 5856103.986880083568394 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1088", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 884.79998779296875, "invlev_up": 863.5, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_205_generated", "manhole_dn": "manhole_206_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386697.095561265014112, 5856103.986880083568394 ], [ 1386699.401158998254687, 5856153.933416903018951 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1089", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 884.79998779296875, "invlev_up": 882.29998779296875, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_206_generated", "manhole_dn": "manhole_207_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386699.401158998254687, 5856153.933416903018951 ], [ 1386715.699191288091242, 5856201.197657831013203 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1090", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 884.79998779296875, "invlev_up": 882.29998779296875, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_207_generated", "manhole_dn": "manhole_208_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386715.699191288091242, 5856201.197657831013203 ], [ 1386741.121203816728666, 5856244.100116757676005 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1091", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 915.9000244140625, "invlev_up": 882.29998779296875, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_208_generated", "manhole_dn": "manhole_209_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386741.121203816728666, 5856244.100116757676005 ], [ 1386774.051378605188802, 5856281.577651324681938 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1092", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_209_generated", "manhole_dn": "manhole_210_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386774.051378605188802, 5856281.577651324681938 ], [ 1386811.583791718119755, 5856314.587093180976808 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1093", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_210_generated", "manhole_dn": "manhole_211_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386811.583791718119755, 5856314.587093180976808 ], [ 1386839.378956499742344, 5856356.087350118905306 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1094", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_211_generated", "manhole_dn": "manhole_212_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386839.378956499742344, 5856356.087350118905306 ], [ 1386855.653891535941511, 5856403.364181768149137 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1095", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_212_generated", "manhole_dn": "manhole_213_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386855.653891535941511, 5856403.364181768149137 ], [ 1386875.714553950354457, 5856449.116945925168693 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1096", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_213_generated", "manhole_dn": "manhole_214_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386875.714553950354457, 5856449.116945925168693 ], [ 1386912.179653002182022, 5856482.939191372133791 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1097", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_214_generated", "manhole_dn": "manhole_215_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386912.179653002182022, 5856482.939191372133791 ], [ 1386944.191176384687424, 5856520.270725904032588 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1098", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 911.79998779296875, "invlev_up": 907.4000244140625, "invlev_dn": 909.29998779296875, "manhole_up": "manhole_215_generated", "manhole_dn": "manhole_216_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386944.191176384687424, 5856520.270725904032588 ], [ 1386964.188513180473819, 5856566.025075756013393 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1099", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.79998779296875, "elevtn_dn": 911.79998779296875, "invlev_up": 909.29998779296875, "invlev_dn": 909.29998779296875, "manhole_up": "manhole_216_generated", "manhole_dn": "manhole_217_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386964.188513180473819, 5856566.025075756013393 ], [ 1386998.825215350603685, 5856599.261941562406719 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1100", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.79998779296875, "elevtn_dn": 932.0, "invlev_up": 909.29998779296875, "invlev_dn": 929.5, "manhole_up": "manhole_217_generated", "manhole_dn": "manhole_218_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386998.825215350603685, 5856599.261941562406719 ], [ 1387044.828526843106374, 5856618.849377661012113 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1101", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 932.0, "invlev_up": 929.5, "invlev_dn": 929.5, "manhole_up": "manhole_218_generated", "manhole_dn": "manhole_219_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387044.828526843106374, 5856618.849377661012113 ], [ 1387090.831838335609064, 5856638.43681376054883 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1102", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 949.9000244140625, "invlev_up": 929.5, "invlev_dn": 947.4000244140625, "manhole_up": "manhole_219_generated", "manhole_dn": "manhole_220_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387090.831838335609064, 5856638.43681376054883 ], [ 1387136.835149827878922, 5856658.024249859154224 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1103", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 949.9000244140625, "elevtn_dn": 924.4000244140625, "invlev_up": 947.4000244140625, "invlev_dn": 921.9000244140625, "manhole_up": "manhole_220_generated", "manhole_dn": "manhole_221_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387136.835149827878922, 5856658.024249859154224 ], [ 1387178.671980312326923, 5856685.128790453076363 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1104", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 924.4000244140625, "elevtn_dn": 924.4000244140625, "invlev_up": 921.9000244140625, "invlev_dn": 921.9000244140625, "manhole_up": "manhole_221_generated", "manhole_dn": "manhole_222_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387178.671980312326923, 5856685.128790453076363 ], [ 1387217.700535611249506, 5856716.320352808572352 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1105", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 924.4000244140625, "elevtn_dn": 940.0, "invlev_up": 921.9000244140625, "invlev_dn": 937.5, "manhole_up": "manhole_222_generated", "manhole_dn": "manhole_223_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387217.700535611249506, 5856716.320352808572352 ], [ 1387252.016686553368345, 5856752.649443434551358 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1106", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.0, "elevtn_dn": 940.0, "invlev_up": 937.5, "invlev_dn": 937.5, "manhole_up": "manhole_223_generated", "manhole_dn": "manhole_224_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387252.016686553368345, 5856752.649443434551358 ], [ 1387284.798919493798167, 5856790.190159549936652 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1107", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.0, "elevtn_dn": 894.29998779296875, "invlev_up": 937.5, "invlev_dn": 891.79998779296875, "manhole_up": "manhole_224_generated", "manhole_dn": "manhole_225_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387284.798919493798167, 5856790.190159549936652 ], [ 1387273.050185391213745, 5856831.931571422144771 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1108", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 894.29998779296875, "elevtn_dn": 891.5, "invlev_up": 891.79998779296875, "invlev_dn": 889.0, "manhole_up": "manhole_225_generated", "manhole_dn": "manhole_226_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387273.050185391213745, 5856831.931571422144771 ], [ 1387226.106990416301414, 5856849.145192969590425 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1109", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.5, "elevtn_dn": 891.5, "invlev_up": 889.0, "invlev_dn": 889.0, "manhole_up": "manhole_226_generated", "manhole_dn": "manhole_227_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387226.106990416301414, 5856849.145192969590425 ], [ 1387179.163795441389084, 5856866.358814516104758 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1110", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.5, "elevtn_dn": 881.0, "invlev_up": 889.0, "invlev_dn": 878.5, "manhole_up": "manhole_227_generated", "manhole_dn": "manhole_228_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387179.163795441389084, 5856866.358814516104758 ], [ 1387132.220600466709584, 5856883.572436063550413 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1111", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_228_generated", "manhole_dn": "manhole_229_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387132.220600466709584, 5856883.572436063550413 ], [ 1387091.513159692520276, 5856911.129930667579174 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1112", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_229_generated", "manhole_dn": "manhole_230_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387091.513159692520276, 5856911.129930667579174 ], [ 1387071.007118243258446, 5856956.15559543017298 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1113", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_230_generated", "manhole_dn": "manhole_231_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387071.007118243258446, 5856956.15559543017298 ], [ 1387043.749112035380676, 5856996.689189162105322 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1114", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 856.5, "invlev_up": 878.5, "invlev_dn": 854.0, "manhole_up": "manhole_231_generated", "manhole_dn": "manhole_232_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387043.749112035380676, 5856996.689189162105322 ], [ 1387004.639443967491388, 5857027.840532388538122 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1115", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_232_generated", "manhole_dn": "manhole_233_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387004.639443967491388, 5857027.840532388538122 ], [ 1386965.529775899834931, 5857058.991875615902245 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1116", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_233_generated", "manhole_dn": "manhole_234_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386965.529775899834931, 5857058.991875615902245 ], [ 1386926.702535050921142, 5857090.440239730291069 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1117", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_234_generated", "manhole_dn": "manhole_235_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386926.702535050921142, 5857090.440239730291069 ], [ 1386899.700979894958436, 5857131.871505072340369 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1118", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_235_generated", "manhole_dn": "manhole_236_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386899.700979894958436, 5857131.871505072340369 ], [ 1386903.6263940166682, 5857181.005935152061284 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1119", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 867.29998779296875, "invlev_up": 854.0, "invlev_dn": 864.79998779296875, "manhole_up": "manhole_236_generated", "manhole_dn": "manhole_237_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386903.6263940166682, 5857181.005935152061284 ], [ 1386920.841401966754347, 5857227.85734468139708 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1120", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 867.29998779296875, "elevtn_dn": 867.29998779296875, "invlev_up": 864.79998779296875, "invlev_dn": 864.79998779296875, "manhole_up": "manhole_237_generated", "manhole_dn": "manhole_238_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386920.841401966754347, 5857227.85734468139708 ], [ 1386940.647245415020734, 5857273.767048302106559 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1121", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 867.29998779296875, "elevtn_dn": 879.0, "invlev_up": 864.79998779296875, "invlev_dn": 876.5, "manhole_up": "manhole_238_generated", "manhole_dn": "manhole_239_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386940.647245415020734, 5857273.767048302106559 ], [ 1386960.453088863519952, 5857319.676751921884716 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1122", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 879.0, "elevtn_dn": 884.5, "invlev_up": 876.5, "invlev_dn": 882.0, "manhole_up": "manhole_239_generated", "manhole_dn": "manhole_240_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386960.453088863519952, 5857319.676751921884716 ], [ 1386980.258932311786339, 5857365.586455542594194 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1123", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 884.5, "invlev_up": 882.0, "invlev_dn": 882.0, "manhole_up": "manhole_240_generated", "manhole_dn": "manhole_241_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386980.258932311786339, 5857365.586455542594194 ], [ 1387000.064775760285556, 5857411.496159162372351 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1124", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 884.5, "invlev_up": 882.0, "invlev_dn": 882.0, "manhole_up": "manhole_241_generated", "manhole_dn": "manhole_242_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387000.064775760285556, 5857411.496159162372351 ], [ 1387007.528902114601806, 5857459.537025099620223 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1125", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 893.20001220703125, "invlev_up": 882.0, "invlev_dn": 890.70001220703125, "manhole_up": "manhole_242_generated", "manhole_dn": "manhole_243_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387007.528902114601806, 5857459.537025099620223 ], [ 1386963.21676475298591, 5857476.629049208015203 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1126", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 893.20001220703125, "elevtn_dn": 893.70001220703125, "invlev_up": 890.70001220703125, "invlev_dn": 891.20001220703125, "manhole_up": "manhole_243_generated", "manhole_dn": "manhole_244_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386963.21676475298591, 5857476.629049208015203 ], [ 1386913.783934087026864, 5857484.135433598421514 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1127", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 893.70001220703125, "elevtn_dn": 893.70001220703125, "invlev_up": 891.20001220703125, "invlev_dn": 891.20001220703125, "manhole_up": "manhole_244_generated", "manhole_dn": "manhole_245_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386913.783934087026864, 5857484.135433598421514 ], [ 1386870.539328352315351, 5857507.055611960589886 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1128", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 893.70001220703125, "elevtn_dn": 889.70001220703125, "invlev_up": 891.20001220703125, "invlev_dn": 887.20001220703125, "manhole_up": "manhole_245_generated", "manhole_dn": "manhole_246_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386870.539328352315351, 5857507.055611960589886 ], [ 1386832.820274166297168, 5857539.877026806585491 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1129", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.70001220703125, "elevtn_dn": 889.70001220703125, "invlev_up": 887.20001220703125, "invlev_dn": 887.20001220703125, "manhole_up": "manhole_246_generated", "manhole_dn": "manhole_247_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386832.820274166297168, 5857539.877026806585491 ], [ 1386795.101531907683238, 5857572.698800123296678 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1130", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.70001220703125, "elevtn_dn": 872.4000244140625, "invlev_up": 887.20001220703125, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_247_generated", "manhole_dn": "manhole_248_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386795.101531907683238, 5857572.698800123296678 ], [ 1386758.257366374600679, 5857606.496797049418092 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1131", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 872.4000244140625, "invlev_up": 869.9000244140625, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_248_generated", "manhole_dn": "manhole_249_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386758.257366374600679, 5857606.496797049418092 ], [ 1386721.502390186069533, 5857640.394349270500243 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1132", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 872.4000244140625, "invlev_up": 869.9000244140625, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_249_generated", "manhole_dn": "manhole_250_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386721.502390186069533, 5857640.394349270500243 ], [ 1386691.639095245627686, 5857680.292891399934888 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1133", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 860.70001220703125, "invlev_up": 869.9000244140625, "invlev_dn": 858.20001220703125, "manhole_up": "manhole_250_generated", "manhole_dn": "manhole_251_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386691.639095245627686, 5857680.292891399934888 ], [ 1386663.127201205352321, 5857721.366519738920033 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1134", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 860.70001220703125, "elevtn_dn": 864.10003662109375, "invlev_up": 858.20001220703125, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_251_generated", "manhole_dn": "manhole_252_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386663.127201205352321, 5857721.366519738920033 ], [ 1386634.70784462057054, 5857762.504245642572641 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1135", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 864.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_252_generated", "manhole_dn": "manhole_253_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386634.70784462057054, 5857762.504245642572641 ], [ 1386606.28848803602159, 5857803.64197154622525 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1136", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 864.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_253_generated", "manhole_dn": "manhole_254_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386606.28848803602159, 5857803.64197154622525 ], [ 1386577.851668093586341, 5857844.766917760483921 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1137", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 836.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 833.60003662109375, "manhole_up": "manhole_254_generated", "manhole_dn": "manhole_255_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386577.851668093586341, 5857844.766917760483921 ], [ 1386559.479123871540651, 5857890.340473555959761 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1138", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 836.10003662109375, "elevtn_dn": 836.10003662109375, "invlev_up": 833.60003662109375, "invlev_dn": 833.60003662109375, "manhole_up": "manhole_255_generated", "manhole_dn": "manhole_256_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386559.479123871540651, 5857890.340473555959761 ], [ 1386576.858566463226452, 5857935.633445805869997 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1139", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 836.10003662109375, "elevtn_dn": 854.9000244140625, "invlev_up": 833.60003662109375, "invlev_dn": 852.4000244140625, "manhole_up": "manhole_256_generated", "manhole_dn": "manhole_257_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386576.858566463226452, 5857935.633445805869997 ], [ 1386619.073707325849682, 5857961.189545376226306 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1140", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.9000244140625, "elevtn_dn": 854.9000244140625, "invlev_up": 852.4000244140625, "invlev_dn": 852.4000244140625, "manhole_up": "manhole_257_generated", "manhole_dn": "manhole_258_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386619.073707325849682, 5857961.189545376226306 ], [ 1386664.860782509436831, 5857981.27706332411617 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1141", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.9000244140625, "elevtn_dn": 871.60003662109375, "invlev_up": 852.4000244140625, "invlev_dn": 869.10003662109375, "manhole_up": "manhole_258_generated", "manhole_dn": "manhole_259_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386664.860782509436831, 5857981.27706332411617 ], [ 1386710.721602912992239, 5858001.195835201069713 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1142", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 871.60003662109375, "elevtn_dn": 865.10003662109375, "invlev_up": 869.10003662109375, "invlev_dn": 862.60003662109375, "manhole_up": "manhole_259_generated", "manhole_dn": "manhole_260_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386710.721602912992239, 5858001.195835201069713 ], [ 1386756.582423316547647, 5858021.114607078954577 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1143", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 865.10003662109375, "elevtn_dn": 864.70001220703125, "invlev_up": 862.60003662109375, "invlev_dn": 862.20001220703125, "manhole_up": "manhole_260_generated", "manhole_dn": "manhole_261_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386756.582423316547647, 5858021.114607078954577 ], [ 1386802.443243720103055, 5858041.033378956839442 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1144", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.70001220703125, "elevtn_dn": 864.70001220703125, "invlev_up": 862.20001220703125, "invlev_dn": 862.20001220703125, "manhole_up": "manhole_261_generated", "manhole_dn": "manhole_262_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386802.443243720103055, 5858041.033378956839442 ], [ 1386848.304064123658463, 5858060.952150834724307 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1145", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.70001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 862.20001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_262_generated", "manhole_dn": "manhole_263_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386848.304064123658463, 5858060.952150834724307 ], [ 1386892.843548113014549, 5858083.471454747952521 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1146", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_263_generated", "manhole_dn": "manhole_264_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386892.843548113014549, 5858083.471454747952521 ], [ 1386931.443847785238177, 5858115.251781782135367 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1147", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 853.60003662109375, "invlev_up": 856.70001220703125, "invlev_dn": 851.10003662109375, "manhole_up": "manhole_264_generated", "manhole_dn": "manhole_265_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386931.443847785238177, 5858115.251781782135367 ], [ 1386970.044147457228974, 5858147.032108817249537 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1148", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 853.60003662109375, "elevtn_dn": 853.60003662109375, "invlev_up": 851.10003662109375, "invlev_dn": 851.10003662109375, "manhole_up": "manhole_265_generated", "manhole_dn": "manhole_266_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386970.044147457228974, 5858147.032108817249537 ], [ 1387008.644447129452601, 5858178.812435851432383 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1149", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 853.60003662109375, "elevtn_dn": 842.4000244140625, "invlev_up": 851.10003662109375, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_266_generated", "manhole_dn": "manhole_267_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387008.644447129452601, 5858178.812435851432383 ], [ 1387047.244746801443398, 5858210.592762886546552 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1150", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 842.4000244140625, "invlev_up": 839.9000244140625, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_267_generated", "manhole_dn": "manhole_268_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387047.244746801443398, 5858210.592762886546552 ], [ 1387085.845046473667026, 5858242.373089920729399 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1151", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 842.4000244140625, "invlev_up": 839.9000244140625, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_268_generated", "manhole_dn": "manhole_269_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387085.845046473667026, 5858242.373089920729399 ], [ 1387124.445346145657822, 5858274.153416955843568 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1152", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 827.60003662109375, "invlev_up": 839.9000244140625, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_269_generated", "manhole_dn": "manhole_270_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387124.445346145657822, 5858274.153416955843568 ], [ 1387163.04564581788145, 5858305.933743990026414 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1153", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_270_generated", "manhole_dn": "manhole_271_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387163.04564581788145, 5858305.933743990026414 ], [ 1387201.829349192325026, 5858337.489215047098696 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1154", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 837.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 835.10003662109375, "manhole_up": "manhole_271_generated", "manhole_dn": "manhole_272_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387201.829349192325026, 5858337.489215047098696 ], [ 1387246.200623227981851, 5858359.687651782296598 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1155", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 837.60003662109375, "elevtn_dn": 837.60003662109375, "invlev_up": 835.10003662109375, "invlev_dn": 835.10003662109375, "manhole_up": "manhole_272_generated", "manhole_dn": "manhole_273_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387246.200623227981851, 5858359.687651782296598 ], [ 1387293.201938283629715, 5858376.741938757710159 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1156", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 837.60003662109375, "elevtn_dn": 843.79998779296875, "invlev_up": 835.10003662109375, "invlev_dn": 841.29998779296875, "manhole_up": "manhole_273_generated", "manhole_dn": "manhole_274_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387293.201938283629715, 5858376.741938757710159 ], [ 1387334.200528149493039, 5858401.732468435540795 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1157", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 843.79998779296875, "elevtn_dn": 822.60003662109375, "invlev_up": 841.29998779296875, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_274_generated", "manhole_dn": "manhole_275_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387334.200528149493039, 5858401.732468435540795 ], [ 1387307.843875054037198, 5858437.110805934295058 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1158", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 822.60003662109375, "invlev_up": 820.10003662109375, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_275_generated", "manhole_dn": "manhole_276_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387307.843875054037198, 5858437.110805934295058 ], [ 1387260.279569417703897, 5858425.045736069791019 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1159", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 820.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_276_generated", "manhole_dn": "manhole_277_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387260.279569417703897, 5858425.045736069791019 ], [ 1387211.448235018178821, 5858414.300554806366563 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1160", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_277_generated", "manhole_dn": "manhole_278_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387211.448235018178821, 5858414.300554806366563 ], [ 1387162.612191663123667, 5858403.576134512200952 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1161", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 822.29998779296875, "invlev_up": 825.10003662109375, "invlev_dn": 819.79998779296875, "manhole_up": "manhole_278_generated", "manhole_dn": "manhole_279_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387162.612191663123667, 5858403.576134512200952 ], [ 1387113.700150535441935, 5858393.210482948459685 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1162", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.29998779296875, "elevtn_dn": 822.29998779296875, "invlev_up": 819.79998779296875, "invlev_dn": 819.79998779296875, "manhole_up": "manhole_279_generated", "manhole_dn": "manhole_280_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387113.700150535441935, 5858393.210482948459685 ], [ 1387064.993171223672107, 5858381.975642333738506 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1163", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.29998779296875, "elevtn_dn": 827.79998779296875, "invlev_up": 819.79998779296875, "invlev_dn": 825.29998779296875, "manhole_up": "manhole_280_generated", "manhole_dn": "manhole_281_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387064.993171223672107, 5858381.975642333738506 ], [ 1387015.796386598376557, 5858376.342007979750633 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1164", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.79998779296875, "elevtn_dn": 827.79998779296875, "invlev_up": 825.29998779296875, "invlev_dn": 825.29998779296875, "manhole_up": "manhole_281_generated", "manhole_dn": "manhole_282_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387015.796386598376557, 5858376.342007979750633 ], [ 1386966.208506174152717, 5858382.746259398758411 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1165", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.79998779296875, "elevtn_dn": 833.9000244140625, "invlev_up": 825.29998779296875, "invlev_dn": 831.4000244140625, "manhole_up": "manhole_282_generated", "manhole_dn": "manhole_283_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386966.208506174152717, 5858382.746259398758411 ], [ 1386916.676812386140227, 5858389.559525708667934 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1166", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 833.9000244140625, "elevtn_dn": 833.9000244140625, "invlev_up": 831.4000244140625, "invlev_dn": 831.4000244140625, "manhole_up": "manhole_283_generated", "manhole_dn": "manhole_284_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386916.676812386140227, 5858389.559525708667934 ], [ 1386867.198860567295924, 5858396.764010772109032 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1167", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 833.9000244140625, "elevtn_dn": 833.20001220703125, "invlev_up": 831.4000244140625, "invlev_dn": 830.70001220703125, "manhole_up": "manhole_284_generated", "manhole_dn": "manhole_285_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386867.198860567295924, 5858396.764010772109032 ], [ 1386820.816385147860274, 5858411.854353901930153 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1168", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 833.20001220703125, "elevtn_dn": 809.60003662109375, "invlev_up": 830.70001220703125, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_285_generated", "manhole_dn": "manhole_286_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386820.816385147860274, 5858411.854353901930153 ], [ 1386841.361234750133008, 5858445.514383808709681 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1169", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 809.79998779296875, "invlev_up": 807.10003662109375, "invlev_dn": 807.29998779296875, "manhole_up": "manhole_286_generated", "manhole_dn": "manhole_287_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386841.361234750133008, 5858445.514383808709681 ], [ 1386890.796275103231892, 5858452.915634987875819 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1170", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.79998779296875, "elevtn_dn": 809.79998779296875, "invlev_up": 807.29998779296875, "invlev_dn": 807.29998779296875, "manhole_up": "manhole_287_generated", "manhole_dn": "manhole_288_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386890.796275103231892, 5858452.915634987875819 ], [ 1386940.277140651131049, 5858460.100081093609333 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1171", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.79998779296875, "elevtn_dn": 805.4000244140625, "invlev_up": 807.29998779296875, "invlev_dn": 802.9000244140625, "manhole_up": "manhole_288_generated", "manhole_dn": "manhole_289_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386940.277140651131049, 5858460.100081093609333 ], [ 1386989.847997799050063, 5858466.483407464809716 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1172", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.4000244140625, "elevtn_dn": 805.4000244140625, "invlev_up": 802.9000244140625, "invlev_dn": 802.9000244140625, "manhole_up": "manhole_289_generated", "manhole_dn": "manhole_290_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386989.847997799050063, 5858466.483407464809716 ], [ 1387039.689648573985323, 5858470.45608530472964 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1173", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.4000244140625, "elevtn_dn": 804.60003662109375, "invlev_up": 802.9000244140625, "invlev_dn": 802.10003662109375, "manhole_up": "manhole_290_generated", "manhole_dn": "manhole_291_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387039.689648573985323, 5858470.45608530472964 ], [ 1387088.843806148739532, 5858479.424946941435337 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1174", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.60003662109375, "elevtn_dn": 809.9000244140625, "invlev_up": 802.10003662109375, "invlev_dn": 807.4000244140625, "manhole_up": "manhole_291_generated", "manhole_dn": "manhole_292_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387088.843806148739532, 5858479.424946941435337 ], [ 1387137.90604472765699, 5858489.061806742101908 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1175", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.9000244140625, "elevtn_dn": 809.9000244140625, "invlev_up": 807.4000244140625, "invlev_dn": 807.4000244140625, "manhole_up": "manhole_292_generated", "manhole_dn": "manhole_293_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387137.90604472765699, 5858489.061806742101908 ], [ 1387186.336529975291342, 5858500.87968063633889 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1176", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.9000244140625, "elevtn_dn": 822.60003662109375, "invlev_up": 807.4000244140625, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_293_generated", "manhole_dn": "manhole_294_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387186.336529975291342, 5858500.87968063633889 ], [ 1387231.661050535272807, 5858521.423059928230941 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1177", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 787.70001220703125, "invlev_up": 820.10003662109375, "invlev_dn": 785.20001220703125, "manhole_up": "manhole_294_generated", "manhole_dn": "manhole_295_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387231.661050535272807, 5858521.423059928230941 ], [ 1387268.120024613803253, 5858555.03504909388721 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1178", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.70001220703125, "elevtn_dn": 787.70001220703125, "invlev_up": 785.20001220703125, "invlev_dn": 785.20001220703125, "manhole_up": "manhole_295_generated", "manhole_dn": "manhole_296_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387268.120024613803253, 5858555.03504909388721 ], [ 1387300.917169471969828, 5858592.775208213366568 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1179", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.70001220703125, "elevtn_dn": 797.10003662109375, "invlev_up": 785.20001220703125, "invlev_dn": 794.60003662109375, "manhole_up": "manhole_296_generated", "manhole_dn": "manhole_297_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387300.917169471969828, 5858592.775208213366568 ], [ 1387340.521646688459441, 5858622.315198052674532 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1180", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 797.10003662109375, "elevtn_dn": 797.10003662109375, "invlev_up": 794.60003662109375, "invlev_dn": 794.60003662109375, "manhole_up": "manhole_297_generated", "manhole_dn": "manhole_298_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387340.521646688459441, 5858622.315198052674532 ], [ 1387387.476920192595571, 5858639.495844470337033 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1181", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 797.10003662109375, "elevtn_dn": 806.10003662109375, "invlev_up": 794.60003662109375, "invlev_dn": 803.60003662109375, "manhole_up": "manhole_298_generated", "manhole_dn": "manhole_299_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387387.476920192595571, 5858639.495844470337033 ], [ 1387436.116963447071612, 5858650.82861250359565 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1182", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.10003662109375, "elevtn_dn": 806.10003662109375, "invlev_up": 803.60003662109375, "invlev_dn": 803.60003662109375, "manhole_up": "manhole_299_generated", "manhole_dn": "manhole_300_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387436.116963447071612, 5858650.82861250359565 ], [ 1387485.194103535497561, 5858660.261457678861916 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1183", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.10003662109375, "elevtn_dn": 807.70001220703125, "invlev_up": 803.60003662109375, "invlev_dn": 805.20001220703125, "manhole_up": "manhole_300_generated", "manhole_dn": "manhole_301_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387485.194103535497561, 5858660.261457678861916 ], [ 1387533.804190448950976, 5858671.493853995576501 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1184", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.70001220703125, "elevtn_dn": 772.20001220703125, "invlev_up": 805.20001220703125, "invlev_dn": 769.70001220703125, "manhole_up": "manhole_301_generated", "manhole_dn": "manhole_302_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387533.804190448950976, 5858671.493853995576501 ], [ 1387580.2968336828053, 5858689.619015210308135 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1185", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.20001220703125, "elevtn_dn": 778.79998779296875, "invlev_up": 769.70001220703125, "invlev_dn": 776.29998779296875, "manhole_up": "manhole_302_generated", "manhole_dn": "manhole_303_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387580.2968336828053, 5858689.619015210308135 ], [ 1387628.455277157016098, 5858703.062848121859133 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1186", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.79998779296875, "elevtn_dn": 778.79998779296875, "invlev_up": 776.29998779296875, "invlev_dn": 776.29998779296875, "manhole_up": "manhole_303_generated", "manhole_dn": "manhole_304_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387628.455277157016098, 5858703.062848121859133 ], [ 1387677.211432087467983, 5858713.7862489502877 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1187", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.79998779296875, "elevtn_dn": 786.70001220703125, "invlev_up": 776.29998779296875, "invlev_dn": 784.20001220703125, "manhole_up": "manhole_304_generated", "manhole_dn": "manhole_305_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387677.211432087467983, 5858713.7862489502877 ], [ 1387726.995392211945727, 5858712.747126803733408 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1188", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.70001220703125, "elevtn_dn": 786.70001220703125, "invlev_up": 784.20001220703125, "invlev_dn": 784.20001220703125, "manhole_up": "manhole_305_generated", "manhole_dn": "manhole_306_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387726.995392211945727, 5858712.747126803733408 ], [ 1387773.343349169706926, 5858725.014477553777397 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1189", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.70001220703125, "elevtn_dn": 797.70001220703125, "invlev_up": 784.20001220703125, "invlev_dn": 795.20001220703125, "manhole_up": "manhole_306_generated", "manhole_dn": "manhole_307_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387773.343349169706926, 5858725.014477553777397 ], [ 1387806.363672176143155, 5858762.310494473204017 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1190", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 797.70001220703125, "elevtn_dn": 797.70001220703125, "invlev_up": 795.20001220703125, "invlev_dn": 795.20001220703125, "manhole_up": "manhole_307_generated", "manhole_dn": "manhole_308_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387806.363672176143155, 5858762.310494473204017 ], [ 1387799.717027904232964, 5858810.149600365199149 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1191", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 797.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 795.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_308_generated", "manhole_dn": "manhole_309_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387799.717027904232964, 5858810.149600365199149 ], [ 1387771.971139753237367, 5858850.86109375115484 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1192", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_309_generated", "manhole_dn": "manhole_310_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387771.971139753237367, 5858850.86109375115484 ], [ 1387723.07675126590766, 5858854.679317841306329 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1193", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_310_generated", "manhole_dn": "manhole_311_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387723.07675126590766, 5858854.679317841306329 ], [ 1387673.274138238513842, 5858850.996178055182099 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1194", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_311_generated", "manhole_dn": "manhole_312_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387673.274138238513842, 5858850.996178055182099 ], [ 1387624.170362570788711, 5858858.384703231044114 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1195", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_312_generated", "manhole_dn": "manhole_313_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387624.170362570788711, 5858858.384703231044114 ], [ 1387575.715393897145987, 5858857.046076283790171 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1196", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_313_generated", "manhole_dn": "manhole_314_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387575.715393897145987, 5858857.046076283790171 ], [ 1387529.438332577701658, 5858838.116818149574101 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1197", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_314_generated", "manhole_dn": "manhole_315_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387529.438332577701658, 5858838.116818149574101 ], [ 1387481.179235466290265, 5858825.222027675248682 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1198", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_315_generated", "manhole_dn": "manhole_316_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387481.179235466290265, 5858825.222027675248682 ], [ 1387432.215501294471323, 5858815.797906777821481 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1199", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 772.79998779296875, "invlev_up": 774.70001220703125, "invlev_dn": 770.29998779296875, "manhole_up": "manhole_316_generated", "manhole_dn": "manhole_317_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387432.215501294471323, 5858815.797906777821481 ], [ 1387382.431881646160036, 5858811.154251328669488 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1200", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.79998779296875, "elevtn_dn": 747.10003662109375, "invlev_up": 770.29998779296875, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_317_generated", "manhole_dn": "manhole_318_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387382.431881646160036, 5858811.154251328669488 ], [ 1387336.607072548242286, 5858824.075685098767281 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1201", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 747.10003662109375, "invlev_up": 744.60003662109375, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_318_generated", "manhole_dn": "manhole_319_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387336.607072548242286, 5858824.075685098767281 ], [ 1387327.458137275883928, 5858870.88596049696207 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1202", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 747.10003662109375, "invlev_up": 744.60003662109375, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_319_generated", "manhole_dn": "manhole_320_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387327.458137275883928, 5858870.88596049696207 ], [ 1387344.619252334116027, 5858917.848375800997019 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1203", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 773.70001220703125, "invlev_up": 744.60003662109375, "invlev_dn": 771.20001220703125, "manhole_up": "manhole_320_generated", "manhole_dn": "manhole_321_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387344.619252334116027, 5858917.848375800997019 ], [ 1387358.089983508689329, 5858965.710649829357862 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1204", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 773.70001220703125, "elevtn_dn": 773.70001220703125, "invlev_up": 771.20001220703125, "invlev_dn": 771.20001220703125, "manhole_up": "manhole_321_generated", "manhole_dn": "manhole_322_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387358.089983508689329, 5858965.710649829357862 ], [ 1387329.564612702699378, 5859003.583583393134177 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1205", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 773.70001220703125, "elevtn_dn": 774.29998779296875, "invlev_up": 771.20001220703125, "invlev_dn": 771.79998779296875, "manhole_up": "manhole_322_generated", "manhole_dn": "manhole_323_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387329.564612702699378, 5859003.583583393134177 ], [ 1387285.783744251355529, 5858993.703191691078246 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1206", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.29998779296875, "elevtn_dn": 774.29998779296875, "invlev_up": 771.79998779296875, "invlev_dn": 771.79998779296875, "manhole_up": "manhole_323_generated", "manhole_dn": "manhole_324_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387285.783744251355529, 5858993.703191691078246 ], [ 1387248.355973182013258, 5858961.31797497626394 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1207", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.29998779296875, "elevtn_dn": 769.4000244140625, "invlev_up": 771.79998779296875, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_324_generated", "manhole_dn": "manhole_325_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387248.355973182013258, 5858961.31797497626394 ], [ 1387199.500433639157563, 5858963.645901591517031 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1208", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 769.4000244140625, "invlev_up": 766.9000244140625, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_325_generated", "manhole_dn": "manhole_326_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387199.500433639157563, 5858963.645901591517031 ], [ 1387151.482699199579656, 5858977.583961015567183 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1209", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 762.60003662109375, "invlev_up": 766.9000244140625, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_326_generated", "manhole_dn": "manhole_327_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387151.482699199579656, 5858977.583961015567183 ], [ 1387103.632611613254994, 5858992.082134889438748 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1210", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 762.60003662109375, "invlev_up": 760.10003662109375, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_327_generated", "manhole_dn": "manhole_328_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387103.632611613254994, 5858992.082134889438748 ], [ 1387055.853339510038495, 5859006.816905959509313 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1211", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 755.79998779296875, "invlev_up": 760.10003662109375, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_328_generated", "manhole_dn": "manhole_329_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387055.853339510038495, 5859006.816905959509313 ], [ 1387008.074067406589165, 5859021.551677029579878 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1212", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_329_generated", "manhole_dn": "manhole_330_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387008.074067406589165, 5859021.551677029579878 ], [ 1386960.294795303372666, 5859036.286448099650443 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1213", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 749.5, "invlev_up": 753.29998779296875, "invlev_dn": 747.0, "manhole_up": "manhole_330_generated", "manhole_dn": "manhole_331_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386960.294795303372666, 5859036.286448099650443 ], [ 1386912.515523200156167, 5859051.021219169721007 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1214", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 749.5, "elevtn_dn": 749.5, "invlev_up": 747.0, "invlev_dn": 747.0, "manhole_up": "manhole_331_generated", "manhole_dn": "manhole_332_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386912.515523200156167, 5859051.021219169721007 ], [ 1386864.736251096706837, 5859065.755990239791572 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1215", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 749.5, "elevtn_dn": 727.10003662109375, "invlev_up": 747.0, "invlev_dn": 724.60003662109375, "manhole_up": "manhole_332_generated", "manhole_dn": "manhole_333_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386864.736251096706837, 5859065.755990239791572 ], [ 1386816.956978993490338, 5859080.490761309862137 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1216", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.10003662109375, "elevtn_dn": 752.29998779296875, "invlev_up": 724.60003662109375, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_333_generated", "manhole_dn": "manhole_334_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386816.956978993490338, 5859080.490761309862137 ], [ 1386769.832018451532349, 5859096.976014334708452 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1217", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 738.0, "invlev_up": 749.79998779296875, "invlev_dn": 735.5, "manhole_up": "manhole_334_generated", "manhole_dn": "manhole_335_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386769.832018451532349, 5859096.976014334708452 ], [ 1386724.102282747160643, 5859117.193917133845389 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1218", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 738.0, "invlev_up": 735.5, "invlev_dn": 735.5, "manhole_up": "manhole_335_generated", "manhole_dn": "manhole_336_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386724.102282747160643, 5859117.193917133845389 ], [ 1386678.372547042788938, 5859137.411819933913648 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1219", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 732.79998779296875, "invlev_up": 735.5, "invlev_dn": 730.29998779296875, "manhole_up": "manhole_336_generated", "manhole_dn": "manhole_337_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386678.372547042788938, 5859137.411819933913648 ], [ 1386632.642811338417232, 5859157.629722733050585 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1220", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.79998779296875, "elevtn_dn": 732.79998779296875, "invlev_up": 730.29998779296875, "invlev_dn": 730.29998779296875, "manhole_up": "manhole_337_generated", "manhole_dn": "manhole_338_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386632.642811338417232, 5859157.629722733050585 ], [ 1386586.913075634045526, 5859177.847625533118844 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1221", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.79998779296875, "elevtn_dn": 732.60003662109375, "invlev_up": 730.29998779296875, "invlev_dn": 730.10003662109375, "manhole_up": "manhole_338_generated", "manhole_dn": "manhole_339_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386586.913075634045526, 5859177.847625533118844 ], [ 1386541.181931287748739, 5859198.062337793409824 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1222", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.60003662109375, "elevtn_dn": 732.60003662109375, "invlev_up": 730.10003662109375, "invlev_dn": 730.10003662109375, "manhole_up": "manhole_339_generated", "manhole_dn": "manhole_340_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386541.181931287748739, 5859198.062337793409824 ], [ 1386495.431538854492828, 5859218.233453613705933 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1223", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.60003662109375, "elevtn_dn": 742.5, "invlev_up": 730.10003662109375, "invlev_dn": 740.0, "manhole_up": "manhole_340_generated", "manhole_dn": "manhole_341_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386495.431538854492828, 5859218.233453613705933 ], [ 1386449.681146421469748, 5859238.404569433070719 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1224", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 742.5, "invlev_up": 740.0, "invlev_dn": 740.0, "manhole_up": "manhole_341_generated", "manhole_dn": "manhole_342_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386449.681146421469748, 5859238.404569433070719 ], [ 1386404.749107032548636, 5859260.314221715554595 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1225", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 717.60003662109375, "invlev_up": 740.0, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_342_generated", "manhole_dn": "manhole_343_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386404.749107032548636, 5859260.314221715554595 ], [ 1386360.756595908896998, 5859284.020064728334546 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1226", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 717.60003662109375, "invlev_up": 715.10003662109375, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_343_generated", "manhole_dn": "manhole_344_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386360.756595908896998, 5859284.020064728334546 ], [ 1386317.622744857333601, 5859309.307279178872705 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1227", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 711.0, "invlev_up": 715.10003662109375, "invlev_dn": 708.5, "manhole_up": "manhole_344_generated", "manhole_dn": "manhole_345_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386317.622744857333601, 5859309.307279178872705 ], [ 1386274.488893805770203, 5859334.594493629410863 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1228", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 711.0, "elevtn_dn": 717.60003662109375, "invlev_up": 708.5, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_345_generated", "manhole_dn": "manhole_346_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386274.488893805770203, 5859334.594493629410863 ], [ 1386231.354723542230204, 5859359.881163572892547 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1229", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 739.0, "invlev_up": 715.10003662109375, "invlev_dn": 736.5, "manhole_up": "manhole_346_generated", "manhole_dn": "manhole_347_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386231.354723542230204, 5859359.881163572892547 ], [ 1386188.788941488368437, 5859385.978958465158939 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1230", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 739.0, "invlev_up": 736.5, "invlev_dn": 736.5, "manhole_up": "manhole_347_generated", "manhole_dn": "manhole_348_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386188.788941488368437, 5859385.978958465158939 ], [ 1386153.170269979629666, 5859420.751348914578557 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1231", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 739.0, "invlev_up": 736.5, "invlev_dn": 736.5, "manhole_up": "manhole_348_generated", "manhole_dn": "manhole_349_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386153.170269979629666, 5859420.751348914578557 ], [ 1386127.241226618411019, 5859463.08446778729558 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1232", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 770.60003662109375, "invlev_up": 736.5, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_349_generated", "manhole_dn": "manhole_350_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386127.241226618411019, 5859463.08446778729558 ], [ 1386108.996456971857697, 5859509.052053713239729 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1233", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_350_generated", "manhole_dn": "manhole_351_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386108.996456971857697, 5859509.052053713239729 ], [ 1386105.954033384332433, 5859558.959127158857882 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1234", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_351_generated", "manhole_dn": "manhole_352_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386105.954033384332433, 5859558.959127158857882 ], [ 1386101.917093347059563, 5859608.782215913757682 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1235", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 779.79998779296875, "invlev_up": 768.10003662109375, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_352_generated", "manhole_dn": "manhole_353_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386101.917093347059563, 5859608.782215913757682 ], [ 1386088.458339030388743, 5859656.652665913105011 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1236", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 779.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_353_generated", "manhole_dn": "manhole_354_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386088.458339030388743, 5859656.652665913105011 ], [ 1386075.652030121767893, 5859704.419184413738549 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1237", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 779.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_354_generated", "manhole_dn": "manhole_355_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386075.652030121767893, 5859704.419184413738549 ], [ 1386076.574770522769541, 5859754.410392354242504 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1238", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_355_generated", "manhole_dn": "manhole_356_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386076.574770522769541, 5859754.410392354242504 ], [ 1386077.497510923538357, 5859804.401600294746459 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1239", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_356_generated", "manhole_dn": "manhole_357_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386077.497510923538357, 5859804.401600294746459 ], [ 1386078.420251324307173, 5859854.392808235250413 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E195", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 814.29998779296875, "elevtn_dn": 802.9000244140625, "invlev_up": 811.79998779296875, "invlev_dn": 800.4000244140625, "manhole_up": "manhole_358_generated", "manhole_dn": "manhole_359_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384050.267680946970358, 5856698.702001548372209 ], [ 1384085.778961833100766, 5856733.441067186184227 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E196", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.9000244140625, "elevtn_dn": 802.9000244140625, "invlev_up": 800.4000244140625, "invlev_dn": 800.4000244140625, "manhole_up": "manhole_359_generated", "manhole_dn": "manhole_360_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384085.778961833100766, 5856733.441067186184227 ], [ 1384122.993944165529683, 5856766.592179889790714 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E197", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.9000244140625, "elevtn_dn": 816.29998779296875, "invlev_up": 800.4000244140625, "invlev_dn": 813.79998779296875, "manhole_up": "manhole_360_generated", "manhole_dn": "manhole_361_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384122.993944165529683, 5856766.592179889790714 ], [ 1384160.350959801580757, 5856799.578122235834599 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E198", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.29998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 813.79998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_361_generated", "manhole_dn": "manhole_362_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384160.350959801580757, 5856799.578122235834599 ], [ 1384198.384374253917485, 5856831.724873264320195 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E199", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 798.29998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_362_generated", "manhole_dn": "manhole_363_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384198.384374253917485, 5856831.724873264320195 ], [ 1384230.112839305773377, 5856870.159957353956997 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E200", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 793.9000244140625, "invlev_up": 798.29998779296875, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_363_generated", "manhole_dn": "manhole_364_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384230.112839305773377, 5856870.159957353956997 ], [ 1384259.121702386764809, 5856910.628996902145445 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E201", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 807.60003662109375, "invlev_up": 791.4000244140625, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_364_generated", "manhole_dn": "manhole_365_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384259.121702386764809, 5856910.628996902145445 ], [ 1384287.023718592710793, 5856951.925833041779697 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E202", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_365_generated", "manhole_dn": "manhole_366_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384287.023718592710793, 5856951.925833041779697 ], [ 1384314.929269487503916, 5856993.22028074786067 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E203", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_366_generated", "manhole_dn": "manhole_367_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384314.929269487503916, 5856993.22028074786067 ], [ 1384344.819752591196448, 5857033.056208833120763 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E204", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_367_generated", "manhole_dn": "manhole_368_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384344.819752591196448, 5857033.056208833120763 ], [ 1384375.891110281459987, 5857072.024425559677184 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E205", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_368_generated", "manhole_dn": "manhole_369_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384375.891110281459987, 5857072.024425559677184 ], [ 1384412.732155854580924, 5857105.507668288424611 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E206", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_369_generated", "manhole_dn": "manhole_370_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384412.732155854580924, 5857105.507668288424611 ], [ 1384450.07948348694481, 5857138.509612204506993 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E207", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_370_generated", "manhole_dn": "manhole_371_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384450.07948348694481, 5857138.509612204506993 ], [ 1384487.42686335532926, 5857171.511497005820274 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E208", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 805.0, "invlev_up": 793.4000244140625, "invlev_dn": 802.5, "manhole_up": "manhole_371_generated", "manhole_dn": "manhole_372_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384487.42686335532926, 5857171.511497005820274 ], [ 1384525.207759798038751, 5857204.014277670532465 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E209", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 796.29998779296875, "invlev_up": 802.5, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_372_generated", "manhole_dn": "manhole_373_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384525.207759798038751, 5857204.014277670532465 ], [ 1384563.111988977529109, 5857236.375065575353801 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E210", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 796.29998779296875, "invlev_up": 793.79998779296875, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_373_generated", "manhole_dn": "manhole_374_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384563.111988977529109, 5857236.375065575353801 ], [ 1384601.016218156786636, 5857268.735853480175138 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E211", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 786.10003662109375, "invlev_up": 793.79998779296875, "invlev_dn": 783.60003662109375, "manhole_up": "manhole_374_generated", "manhole_dn": "manhole_375_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384601.016218156786636, 5857268.735853480175138 ], [ 1384638.920447336044163, 5857301.096641384996474 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E212", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.10003662109375, "elevtn_dn": 794.29998779296875, "invlev_up": 783.60003662109375, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_375_generated", "manhole_dn": "manhole_376_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384638.920447336044163, 5857301.096641384996474 ], [ 1384669.604954990325496, 5857340.313404724933207 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E213", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 794.29998779296875, "invlev_up": 791.79998779296875, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_376_generated", "manhole_dn": "manhole_377_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384669.604954990325496, 5857340.313404724933207 ], [ 1384699.518247769214213, 5857380.104403200559318 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E214", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 794.29998779296875, "invlev_up": 791.79998779296875, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_377_generated", "manhole_dn": "manhole_378_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384699.518247769214213, 5857380.104403200559318 ], [ 1384719.806332413339987, 5857425.627417215146124 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E215", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 782.0, "invlev_up": 791.79998779296875, "invlev_dn": 779.5, "manhole_up": "manhole_378_generated", "manhole_dn": "manhole_379_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384719.806332413339987, 5857425.627417215146124 ], [ 1384740.094417057465762, 5857471.150431229732931 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E216", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 782.0, "elevtn_dn": 789.70001220703125, "invlev_up": 779.5, "invlev_dn": 787.20001220703125, "manhole_up": "manhole_379_generated", "manhole_dn": "manhole_380_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384740.094417057465762, 5857471.150431229732931 ], [ 1384760.382501701591536, 5857516.673445244319737 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E217", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 789.70001220703125, "elevtn_dn": 789.70001220703125, "invlev_up": 787.20001220703125, "invlev_dn": 787.20001220703125, "manhole_up": "manhole_380_generated", "manhole_dn": "manhole_381_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384760.382501701591536, 5857516.673445244319737 ], [ 1384780.670586345717311, 5857562.196459258906543 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E218", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 789.70001220703125, "elevtn_dn": 796.5, "invlev_up": 787.20001220703125, "invlev_dn": 794.0, "manhole_up": "manhole_381_generated", "manhole_dn": "manhole_382_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384780.670586345717311, 5857562.196459258906543 ], [ 1384802.672203443944454, 5857606.838341221213341 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E219", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.5, "elevtn_dn": 771.9000244140625, "invlev_up": 794.0, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_382_generated", "manhole_dn": "manhole_383_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384802.672203443944454, 5857606.838341221213341 ], [ 1384827.896526007680222, 5857649.823044718243182 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E220", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_383_generated", "manhole_dn": "manhole_384_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384827.896526007680222, 5857649.823044718243182 ], [ 1384854.757882944308221, 5857691.606820800341666 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E221", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_384_generated", "manhole_dn": "manhole_385_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384854.757882944308221, 5857691.606820800341666 ], [ 1384888.185768931638449, 5857728.573395187035203 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E222", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_385_generated", "manhole_dn": "manhole_386_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384888.185768931638449, 5857728.573395187035203 ], [ 1384921.613654918735847, 5857765.539969574660063 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E223", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 755.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_386_generated", "manhole_dn": "manhole_387_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384921.613654918735847, 5857765.539969574660063 ], [ 1384956.145453942706808, 5857801.445756647735834 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E224", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 755.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_387_generated", "manhole_dn": "manhole_388_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384956.145453942706808, 5857801.445756647735834 ], [ 1384991.751306539867073, 5857836.319449373520911 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E225", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 746.0, "invlev_up": 755.4000244140625, "invlev_dn": 743.5, "manhole_up": "manhole_388_generated", "manhole_dn": "manhole_389_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384991.751306539867073, 5857836.319449373520911 ], [ 1385027.357159137027338, 5857871.193142099305987 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E226", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 746.0, "elevtn_dn": 755.79998779296875, "invlev_up": 743.5, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_389_generated", "manhole_dn": "manhole_390_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385027.357159137027338, 5857871.193142099305987 ], [ 1385062.963011734187603, 5857906.066834825091064 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E227", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 728.60003662109375, "invlev_up": 753.29998779296875, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_390_generated", "manhole_dn": "manhole_391_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385062.963011734187603, 5857906.066834825091064 ], [ 1385098.568864331347868, 5857940.940527551807463 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E228", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 728.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_391_generated", "manhole_dn": "manhole_392_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385098.568864331347868, 5857940.940527551807463 ], [ 1385135.753846400883049, 5857974.029479116201401 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E229", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 728.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_392_generated", "manhole_dn": "manhole_393_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385135.753846400883049, 5857974.029479116201401 ], [ 1385175.738456205930561, 5858003.622975903563201 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E230", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 735.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 733.10003662109375, "manhole_up": "manhole_393_generated", "manhole_dn": "manhole_394_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385175.738456205930561, 5858003.622975903563201 ], [ 1385218.653756857383996, 5858028.965196672827005 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E231", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 735.60003662109375, "elevtn_dn": 735.60003662109375, "invlev_up": 733.10003662109375, "invlev_dn": 733.10003662109375, "manhole_up": "manhole_394_generated", "manhole_dn": "manhole_395_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385218.653756857383996, 5858028.965196672827005 ], [ 1385262.454936756985262, 5858052.706982978619635 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E232", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 735.60003662109375, "elevtn_dn": 742.0, "invlev_up": 733.10003662109375, "invlev_dn": 739.5, "manhole_up": "manhole_395_generated", "manhole_dn": "manhole_396_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385262.454936756985262, 5858052.706982978619635 ], [ 1385306.715555034345016, 5858075.618745312094688 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E233", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.0, "elevtn_dn": 742.0, "invlev_up": 739.5, "invlev_dn": 739.5, "manhole_up": "manhole_396_generated", "manhole_dn": "manhole_397_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385306.715555034345016, 5858075.618745312094688 ], [ 1385350.97617331170477, 5858098.530507644638419 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E234", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.0, "elevtn_dn": 736.0, "invlev_up": 739.5, "invlev_dn": 733.5, "manhole_up": "manhole_397_generated", "manhole_dn": "manhole_398_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385350.97617331170477, 5858098.530507644638419 ], [ 1385395.236791589297354, 5858121.442269978113472 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E235", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 736.0, "elevtn_dn": 736.0, "invlev_up": 733.5, "invlev_dn": 733.5, "manhole_up": "manhole_398_generated", "manhole_dn": "manhole_399_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385395.236791589297354, 5858121.442269978113472 ], [ 1385439.497409866657108, 5858144.354032310657203 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E236", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 736.0, "elevtn_dn": 737.9000244140625, "invlev_up": 733.5, "invlev_dn": 735.4000244140625, "manhole_up": "manhole_399_generated", "manhole_dn": "manhole_400_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385439.497409866657108, 5858144.354032310657203 ], [ 1385483.758028144016862, 5858167.265794644132257 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E237", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.9000244140625, "elevtn_dn": 737.9000244140625, "invlev_up": 735.4000244140625, "invlev_dn": 735.4000244140625, "manhole_up": "manhole_400_generated", "manhole_dn": "manhole_401_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385483.758028144016862, 5858167.265794644132257 ], [ 1385528.018646421376616, 5858190.17755697760731 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E238", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.9000244140625, "elevtn_dn": 727.29998779296875, "invlev_up": 735.4000244140625, "invlev_dn": 724.79998779296875, "manhole_up": "manhole_401_generated", "manhole_dn": "manhole_402_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385528.018646421376616, 5858190.17755697760731 ], [ 1385571.606102279853076, 5858214.277655217796564 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E239", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.29998779296875, "elevtn_dn": 727.29998779296875, "invlev_up": 724.79998779296875, "invlev_dn": 724.79998779296875, "manhole_up": "manhole_402_generated", "manhole_dn": "manhole_403_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385571.606102279853076, 5858214.277655217796564 ], [ 1385614.013400863157585, 5858240.461089110001922 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E240", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.29998779296875, "elevtn_dn": 690.60003662109375, "invlev_up": 724.79998779296875, "invlev_dn": 688.10003662109375, "manhole_up": "manhole_403_generated", "manhole_dn": "manhole_404_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385614.013400863157585, 5858240.461089110001922 ], [ 1385656.420699446462095, 5858266.644523002207279 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E241", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 690.60003662109375, "elevtn_dn": 733.60003662109375, "invlev_up": 688.10003662109375, "invlev_dn": 731.10003662109375, "manhole_up": "manhole_404_generated", "manhole_dn": "manhole_405_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385656.420699446462095, 5858266.644523002207279 ], [ 1385698.773111530812457, 5858292.8961898451671 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E242", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 733.60003662109375, "elevtn_dn": 733.60003662109375, "invlev_up": 731.10003662109375, "invlev_dn": 731.10003662109375, "manhole_up": "manhole_405_generated", "manhole_dn": "manhole_406_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385698.773111530812457, 5858292.8961898451671 ], [ 1385733.435650466475636, 5858328.707634637132287 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E243", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 733.60003662109375, "elevtn_dn": 721.60003662109375, "invlev_up": 731.10003662109375, "invlev_dn": 719.10003662109375, "manhole_up": "manhole_406_generated", "manhole_dn": "manhole_407_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385733.435650466475636, 5858328.707634637132287 ], [ 1385768.098189401905984, 5858364.519079428166151 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E244", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 721.60003662109375, "elevtn_dn": 721.60003662109375, "invlev_up": 719.10003662109375, "invlev_dn": 719.10003662109375, "manhole_up": "manhole_407_generated", "manhole_dn": "manhole_408_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385768.098189401905984, 5858364.519079428166151 ], [ 1385795.882535298354924, 5858405.467093757353723 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E245", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 721.60003662109375, "elevtn_dn": 739.0, "invlev_up": 719.10003662109375, "invlev_dn": 736.5, "manhole_up": "manhole_408_generated", "manhole_dn": "manhole_409_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385795.882535298354924, 5858405.467093757353723 ], [ 1385820.377634756267071, 5858448.871486231684685 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E246", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 727.79998779296875, "invlev_up": 736.5, "invlev_dn": 725.29998779296875, "manhole_up": "manhole_409_generated", "manhole_dn": "manhole_410_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385820.377634756267071, 5858448.871486231684685 ], [ 1385841.084314390551299, 5858493.920932004228234 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E247", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.79998779296875, "elevtn_dn": 727.79998779296875, "invlev_up": 725.29998779296875, "invlev_dn": 725.29998779296875, "manhole_up": "manhole_410_generated", "manhole_dn": "manhole_411_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385841.084314390551299, 5858493.920932004228234 ], [ 1385856.076261736918241, 5858541.451897682622075 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E248", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.79998779296875, "elevtn_dn": 734.9000244140625, "invlev_up": 725.29998779296875, "invlev_dn": 732.4000244140625, "manhole_up": "manhole_411_generated", "manhole_dn": "manhole_412_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385856.076261736918241, 5858541.451897682622075 ], [ 1385865.668899663724005, 5858590.250006795860827 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E249", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 734.9000244140625, "elevtn_dn": 734.9000244140625, "invlev_up": 732.4000244140625, "invlev_dn": 732.4000244140625, "manhole_up": "manhole_412_generated", "manhole_dn": "manhole_413_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385865.668899663724005, 5858590.250006795860827 ], [ 1385873.387286560609937, 5858639.487976770848036 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E250", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 734.9000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 732.4000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_413_generated", "manhole_dn": "manhole_414_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385873.387286560609937, 5858639.487976770848036 ], [ 1385875.017949819331989, 5858689.287253175862134 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E251", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 748.9000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_414_generated", "manhole_dn": "manhole_415_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385875.017949819331989, 5858689.287253175862134 ], [ 1385876.432928551919758, 5858739.106416343711317 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E252", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 748.9000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_415_generated", "manhole_dn": "manhole_416_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385876.432928551919758, 5858739.106416343711317 ], [ 1385878.329821793129668, 5858788.908141564577818 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E253", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 748.9000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_416_generated", "manhole_dn": "manhole_417_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385878.329821793129668, 5858788.908141564577818 ], [ 1385880.51921496167779, 5858838.69928275514394 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E254", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_417_generated", "manhole_dn": "manhole_418_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385880.51921496167779, 5858838.69928275514394 ], [ 1385882.620351102668792, 5858888.493530485779047 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E255", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_418_generated", "manhole_dn": "manhole_419_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385882.620351102668792, 5858888.493530485779047 ], [ 1385883.937443709466606, 5858938.315377607010305 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E256", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 766.10003662109375, "invlev_up": 757.20001220703125, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_419_generated", "manhole_dn": "manhole_420_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385883.937443709466606, 5858938.315377607010305 ], [ 1385885.254538560518995, 5858988.137224668636918 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E257", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 766.10003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_420_generated", "manhole_dn": "manhole_421_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385885.254538560518995, 5858988.137224668636918 ], [ 1385890.650534195825458, 5859037.630400610156357 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E258", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 766.10003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_421_generated", "manhole_dn": "manhole_422_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385890.650534195825458, 5859037.630400610156357 ], [ 1385901.777442803606391, 5859086.09239396546036 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E259", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 768.60003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 766.10003662109375, "manhole_up": "manhole_422_generated", "manhole_dn": "manhole_423_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385901.777442803606391, 5859086.09239396546036 ], [ 1385915.397954803425819, 5859134.03436760418117 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E260", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.60003662109375, "elevtn_dn": 762.79998779296875, "invlev_up": 766.10003662109375, "invlev_dn": 760.29998779296875, "manhole_up": "manhole_423_generated", "manhole_dn": "manhole_424_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385915.397954803425819, 5859134.03436760418117 ], [ 1385928.42605347908102, 5859182.139209139160812 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E261", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.79998779296875, "elevtn_dn": 762.5, "invlev_up": 760.29998779296875, "invlev_dn": 760.0, "manhole_up": "manhole_424_generated", "manhole_dn": "manhole_425_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385928.42605347908102, 5859182.139209139160812 ], [ 1385941.228082312969491, 5859230.306202415376902 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E262", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 762.5, "invlev_up": 760.0, "invlev_dn": 760.0, "manhole_up": "manhole_425_generated", "manhole_dn": "manhole_426_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385941.228082312969491, 5859230.306202415376902 ], [ 1385945.092689140234143, 5859279.734331246465445 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E263", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 762.5, "invlev_up": 760.0, "invlev_dn": 760.0, "manhole_up": "manhole_426_generated", "manhole_dn": "manhole_427_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385945.092689140234143, 5859279.734331246465445 ], [ 1385937.902412303024903, 5859328.779896341264248 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E264", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 778.0, "invlev_up": 760.0, "invlev_dn": 775.5, "manhole_up": "manhole_427_generated", "manhole_dn": "manhole_428_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.902412303024903, 5859328.779896341264248 ], [ 1385932.795075723901391, 5859378.173214216716588 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E265", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 778.0, "invlev_up": 775.5, "invlev_dn": 775.5, "manhole_up": "manhole_428_generated", "manhole_dn": "manhole_429_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385932.795075723901391, 5859378.173214216716588 ], [ 1385937.702695531537756, 5859427.770254967734218 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E266", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 778.0, "invlev_up": 775.5, "invlev_dn": 775.5, "manhole_up": "manhole_429_generated", "manhole_dn": "manhole_430_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.702695531537756, 5859427.770254967734218 ], [ 1385939.035937832202762, 5859477.50230407807976 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E267", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 795.9000244140625, "invlev_up": 775.5, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_430_generated", "manhole_dn": "manhole_431_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385939.035937832202762, 5859477.50230407807976 ], [ 1385937.883638251805678, 5859527.328234969638288 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E268", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_431_generated", "manhole_dn": "manhole_432_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.883638251805678, 5859527.328234969638288 ], [ 1385940.515994266141206, 5859576.989168248139322 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E269", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_432_generated", "manhole_dn": "manhole_433_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385940.515994266141206, 5859576.989168248139322 ], [ 1385950.701545101590455, 5859625.530176519416273 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E270", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 815.0, "invlev_up": 793.4000244140625, "invlev_dn": 812.5, "manhole_up": "manhole_433_generated", "manhole_dn": "manhole_434_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385950.701545101590455, 5859625.530176519416273 ], [ 1385970.467743494315073, 5859670.991298755630851 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E271", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 815.0, "elevtn_dn": 815.0, "invlev_up": 812.5, "invlev_dn": 812.5, "manhole_up": "manhole_434_generated", "manhole_dn": "manhole_435_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385970.467743494315073, 5859670.991298755630851 ], [ 1386011.983088220236823, 5859697.862916950136423 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E272", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 815.0, "elevtn_dn": 779.79998779296875, "invlev_up": 812.5, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_435_generated", "manhole_dn": "manhole_436_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386011.983088220236823, 5859697.862916950136423 ], [ 1386052.213596233632416, 5859727.119808158837259 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E273", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_436_generated", "manhole_dn": "manhole_437_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386052.213596233632416, 5859727.119808158837259 ], [ 1386046.501012831227854, 5859771.612671964801848 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E274", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_437_generated", "manhole_dn": "manhole_438_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386046.501012831227854, 5859771.612671964801848 ], [ 1386026.809695787727833, 5859816.873920152895153 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E275", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_438_generated", "manhole_dn": "manhole_439_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386026.809695787727833, 5859816.873920152895153 ], [ 1386030.149607364553958, 5859866.379009906202555 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E276", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_439_generated", "manhole_dn": "manhole_440_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386030.149607364553958, 5859866.379009906202555 ], [ 1386045.250939248362556, 5859913.859036295674741 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 798.29998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_441_generated", "manhole_dn": "manhole_442_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384196.861816460033879, 5856829.88048410974443 ], [ 1384235.22519311751239, 5856854.977665597572923 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 793.9000244140625, "invlev_up": 798.29998779296875, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_442_generated", "manhole_dn": "manhole_443_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384235.22519311751239, 5856854.977665597572923 ], [ 1384263.450329831801355, 5856892.038370934315026 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 793.9000244140625, "invlev_up": 791.4000244140625, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_443_generated", "manhole_dn": "manhole_444_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384263.450329831801355, 5856892.038370934315026 ], [ 1384291.675466545857489, 5856929.099076271057129 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 807.60003662109375, "invlev_up": 791.4000244140625, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_444_generated", "manhole_dn": "manhole_445_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384291.675466545857489, 5856929.099076271057129 ], [ 1384319.900603260146454, 5856966.159781608730555 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_445_generated", "manhole_dn": "manhole_446_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384319.900603260146454, 5856966.159781608730555 ], [ 1384347.205867683747783, 5857003.894510924816132 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 799.0, "invlev_up": 805.10003662109375, "invlev_dn": 796.5, "manhole_up": "manhole_446_generated", "manhole_dn": "manhole_447_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384347.205867683747783, 5857003.894510924816132 ], [ 1384380.322691001230851, 5857036.360282040201128 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 799.0, "elevtn_dn": 807.60003662109375, "invlev_up": 796.5, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_447_generated", "manhole_dn": "manhole_448_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384380.322691001230851, 5857036.360282040201128 ], [ 1384415.156610523350537, 5857067.291694445535541 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_448_generated", "manhole_dn": "manhole_449_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384415.156610523350537, 5857067.291694445535541 ], [ 1384449.343575850594789, 5857098.828100205399096 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_449_generated", "manhole_dn": "manhole_450_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384449.343575850594789, 5857098.828100205399096 ], [ 1384470.004810179118067, 5857139.926174183376133 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_450_generated", "manhole_dn": "manhole_451_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384470.004810179118067, 5857139.926174183376133 ], [ 1384484.18076178082265, 5857184.301805094815791 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_452_generated", "manhole_dn": "manhole_453_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384289.06552429520525, 5856954.947841017507017 ], [ 1384305.049610810354352, 5856994.88734863139689 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_453_generated", "manhole_dn": "manhole_454_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384305.049610810354352, 5856994.88734863139689 ], [ 1384321.033697325503454, 5857034.82685624435544 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 799.0, "invlev_up": 805.10003662109375, "invlev_dn": 796.5, "manhole_up": "manhole_454_generated", "manhole_dn": "manhole_455_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384321.033697325503454, 5857034.82685624435544 ], [ 1384347.445656489115208, 5857068.672038841992617 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 799.0, "elevtn_dn": 807.60003662109375, "invlev_up": 796.5, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_455_generated", "manhole_dn": "manhole_456_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384347.445656489115208, 5857068.672038841992617 ], [ 1384374.130628447979689, 5857102.406951548531651 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_456_generated", "manhole_dn": "manhole_457_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384374.130628447979689, 5857102.406951548531651 ], [ 1384399.587644136510789, 5857137.08541233278811 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_457_generated", "manhole_dn": "manhole_458_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384399.587644136510789, 5857137.08541233278811 ], [ 1384425.04465982504189, 5857171.763873117044568 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_458_generated", "manhole_dn": "manhole_459_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384425.04465982504189, 5857171.763873117044568 ], [ 1384456.866520966170356, 5857200.577977900393307 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_15_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_15", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_15", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_459_generated", "manhole_dn": "manhole_460_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384456.866520966170356, 5857200.577977900393307 ], [ 1384480.774830641923472, 5857195.244455400854349 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_17_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_17", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_17", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 805.0, "invlev_up": 793.4000244140625, "invlev_dn": 802.5, "manhole_up": "manhole_459_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384456.866520966170356, 5857200.577977900393307 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_18_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_18", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_18", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_462_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384493.329776774393395, 5857201.952337642200291 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_19_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_19", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_19", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_462_generated", "manhole_dn": "manhole_463_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384493.329776774393395, 5857201.952337642200291 ], [ 1384511.321100181667134, 5857246.008046119473875 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_19_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_19", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_19", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_463_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384511.321100181667134, 5857246.008046119473875 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 796.29998779296875, "invlev_up": 802.5, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_464_generated", "manhole_dn": "manhole_465_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384512.484966830350459, 5857248.858029337599874 ], [ 1384550.208547196350992, 5857281.609186780638993 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 796.29998779296875, "invlev_up": 793.79998779296875, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_465_generated", "manhole_dn": "manhole_466_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384550.208547196350992, 5857281.609186780638993 ], [ 1384587.932127562351525, 5857314.360344224609435 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 809.10003662109375, "invlev_up": 793.79998779296875, "invlev_dn": 806.60003662109375, "manhole_up": "manhole_466_generated", "manhole_dn": "manhole_467_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384587.932127562351525, 5857314.360344224609435 ], [ 1384608.456866907887161, 5857358.785165345296264 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.10003662109375, "elevtn_dn": 809.10003662109375, "invlev_up": 806.60003662109375, "invlev_dn": 806.60003662109375, "manhole_up": "manhole_467_generated", "manhole_dn": "manhole_468_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384608.456866907887161, 5857358.785165345296264 ], [ 1384624.966163935838267, 5857405.935456342995167 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.10003662109375, "elevtn_dn": 794.29998779296875, "invlev_up": 806.60003662109375, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_468_generated", "manhole_dn": "manhole_469_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384624.966163935838267, 5857405.935456342995167 ], [ 1384639.938245237572119, 5857453.586039477027953 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 812.4000244140625, "invlev_up": 791.79998779296875, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_469_generated", "manhole_dn": "manhole_470_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384639.938245237572119, 5857453.586039477027953 ], [ 1384654.3423755497206, 5857501.421464210376143 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 812.4000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_470_generated", "manhole_dn": "manhole_471_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384654.3423755497206, 5857501.421464210376143 ], [ 1384665.748858094681054, 5857550.055336253717542 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 812.4000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_471_generated", "manhole_dn": "manhole_472_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384665.748858094681054, 5857550.055336253717542 ], [ 1384677.04772660904564, 5857598.717872150242329 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 818.9000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 816.4000244140625, "manhole_up": "manhole_472_generated", "manhole_dn": "manhole_473_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384677.04772660904564, 5857598.717872150242329 ], [ 1384688.346595123410225, 5857647.380408045835793 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.9000244140625, "elevtn_dn": 818.9000244140625, "invlev_up": 816.4000244140625, "invlev_dn": 816.4000244140625, "manhole_up": "manhole_473_generated", "manhole_dn": "manhole_474_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384688.346595123410225, 5857647.380408045835793 ], [ 1384699.64546363777481, 5857696.042943941429257 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.9000244140625, "elevtn_dn": 791.0, "invlev_up": 816.4000244140625, "invlev_dn": 788.5, "manhole_up": "manhole_474_generated", "manhole_dn": "manhole_475_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384699.64546363777481, 5857696.042943941429257 ], [ 1384710.944332152139395, 5857744.705479837954044 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 771.9000244140625, "invlev_up": 788.5, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_475_generated", "manhole_dn": "manhole_476_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384710.944332152139395, 5857744.705479837954044 ], [ 1384726.848783193388954, 5857791.671307560056448 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_476_generated", "manhole_dn": "manhole_477_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384726.848783193388954, 5857791.671307560056448 ], [ 1384753.929338480113074, 5857833.199649352580309 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_477_generated", "manhole_dn": "manhole_478_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384753.929338480113074, 5857833.199649352580309 ], [ 1384783.627482200739905, 5857873.006575288251042 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 791.0, "invlev_up": 769.4000244140625, "invlev_dn": 788.5, "manhole_up": "manhole_478_generated", "manhole_dn": "manhole_479_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384783.627482200739905, 5857873.006575288251042 ], [ 1384795.018452654592693, 5857920.637507135979831 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 791.0, "invlev_up": 788.5, "invlev_dn": 788.5, "manhole_up": "manhole_479_generated", "manhole_dn": "manhole_480_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384795.018452654592693, 5857920.637507135979831 ], [ 1384785.075932276435196, 5857969.445633230730891 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 820.10003662109375, "invlev_up": 788.5, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_480_generated", "manhole_dn": "manhole_481_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384785.075932276435196, 5857969.445633230730891 ], [ 1384771.479073295136914, 5858017.516749874688685 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 820.10003662109375, "invlev_up": 817.60003662109375, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_481_generated", "manhole_dn": "manhole_482_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384771.479073295136914, 5858017.516749874688685 ], [ 1384763.32518996251747, 5858066.675425447523594 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 820.10003662109375, "invlev_up": 817.60003662109375, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_482_generated", "manhole_dn": "manhole_483_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384763.32518996251747, 5858066.675425447523594 ], [ 1384757.405406558187678, 5858116.280495692044497 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 847.0, "invlev_up": 817.60003662109375, "invlev_dn": 844.5, "manhole_up": "manhole_483_generated", "manhole_dn": "manhole_484_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384757.405406558187678, 5858116.280495692044497 ], [ 1384746.211964494548738, 5858164.956996791996062 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 847.0, "invlev_up": 844.5, "invlev_dn": 844.5, "manhole_up": "manhole_484_generated", "manhole_dn": "manhole_485_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384746.211964494548738, 5858164.956996791996062 ], [ 1384738.028054837835953, 5858213.862443570047617 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 847.0, "invlev_up": 844.5, "invlev_dn": 844.5, "manhole_up": "manhole_485_generated", "manhole_dn": "manhole_486_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384738.028054837835953, 5858213.862443570047617 ], [ 1384756.479259133106098, 5858259.218586039729416 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 833.20001220703125, "invlev_up": 844.5, "invlev_dn": 830.70001220703125, "manhole_up": "manhole_486_generated", "manhole_dn": "manhole_487_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384756.479259133106098, 5858259.218586039729416 ], [ 1384792.653981153853238, 5858293.25339647103101 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 833.20001220703125, "elevtn_dn": 762.29998779296875, "invlev_up": 830.70001220703125, "invlev_dn": 759.79998779296875, "manhole_up": "manhole_487_generated", "manhole_dn": "manhole_488_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384792.653981153853238, 5858293.25339647103101 ], [ 1384839.146884107263759, 5858310.949097327888012 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.29998779296875, "elevtn_dn": 762.29998779296875, "invlev_up": 759.79998779296875, "invlev_dn": 759.79998779296875, "manhole_up": "manhole_488_generated", "manhole_dn": "manhole_489_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384839.146884107263759, 5858310.949097327888012 ], [ 1384888.517509665805846, 5858307.535864246077836 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.29998779296875, "elevtn_dn": 751.0, "invlev_up": 759.79998779296875, "invlev_dn": 748.5, "manhole_up": "manhole_489_generated", "manhole_dn": "manhole_490_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384888.517509665805846, 5858307.535864246077836 ], [ 1384936.622762819286436, 5858294.068231076002121 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.0, "elevtn_dn": 751.0, "invlev_up": 748.5, "invlev_dn": 748.5, "manhole_up": "manhole_490_generated", "manhole_dn": "manhole_491_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384936.622762819286436, 5858294.068231076002121 ], [ 1384984.637113286415115, 5858280.272530450485647 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.0, "elevtn_dn": 743.20001220703125, "invlev_up": 748.5, "invlev_dn": 740.70001220703125, "manhole_up": "manhole_491_generated", "manhole_dn": "manhole_492_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384984.637113286415115, 5858280.272530450485647 ], [ 1385032.633651287527755, 5858266.414710656739771 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 743.20001220703125, "elevtn_dn": 743.20001220703125, "invlev_up": 740.70001220703125, "invlev_dn": 740.70001220703125, "manhole_up": "manhole_492_generated", "manhole_dn": "manhole_493_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385032.633651287527755, 5858266.414710656739771 ], [ 1385081.886840383987874, 5858258.136644747108221 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 743.20001220703125, "elevtn_dn": 747.60003662109375, "invlev_up": 740.70001220703125, "invlev_dn": 745.10003662109375, "manhole_up": "manhole_493_generated", "manhole_dn": "manhole_494_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385081.886840383987874, 5858258.136644747108221 ], [ 1385131.310463621048257, 5858263.211211345158517 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.60003662109375, "elevtn_dn": 756.79998779296875, "invlev_up": 745.10003662109375, "invlev_dn": 754.29998779296875, "manhole_up": "manhole_494_generated", "manhole_dn": "manhole_495_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385131.310463621048257, 5858263.211211345158517 ], [ 1385177.729395114118233, 5858281.168494092300534 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.79998779296875, "elevtn_dn": 758.9000244140625, "invlev_up": 754.29998779296875, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_495_generated", "manhole_dn": "manhole_496_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385177.729395114118233, 5858281.168494092300534 ], [ 1385219.95651927171275, 5858307.84242575801909 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 758.9000244140625, "invlev_up": 756.4000244140625, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_496_generated", "manhole_dn": "manhole_497_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385219.95651927171275, 5858307.84242575801909 ], [ 1385261.864506913116202, 5858335.034840167500079 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 756.29998779296875, "invlev_up": 756.4000244140625, "invlev_dn": 753.79998779296875, "manhole_up": "manhole_497_generated", "manhole_dn": "manhole_498_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385261.864506913116202, 5858335.034840167500079 ], [ 1385305.658712412696332, 5858358.964500648900867 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 756.29998779296875, "invlev_up": 753.79998779296875, "invlev_dn": 753.79998779296875, "manhole_up": "manhole_498_generated", "manhole_dn": "manhole_499_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385305.658712412696332, 5858358.964500648900867 ], [ 1385350.136275847908109, 5858381.712097893469036 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 750.79998779296875, "invlev_up": 753.79998779296875, "invlev_dn": 748.29998779296875, "manhole_up": "manhole_499_generated", "manhole_dn": "manhole_500_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385350.136275847908109, 5858381.712097893469036 ], [ 1385394.617425152566284, 5858404.452682325616479 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 750.79998779296875, "elevtn_dn": 760.20001220703125, "invlev_up": 748.29998779296875, "invlev_dn": 757.70001220703125, "manhole_up": "manhole_500_generated", "manhole_dn": "manhole_501_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385394.617425152566284, 5858404.452682325616479 ], [ 1385439.245915542822331, 5858426.901898948475718 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 760.20001220703125, "elevtn_dn": 754.29998779296875, "invlev_up": 757.70001220703125, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_501_generated", "manhole_dn": "manhole_502_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385439.245915542822331, 5858426.901898948475718 ], [ 1385483.926139793125913, 5858449.248809035867453 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 754.29998779296875, "invlev_up": 751.79998779296875, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_502_generated", "manhole_dn": "manhole_503_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385483.926139793125913, 5858449.248809035867453 ], [ 1385525.860647091642022, 5858475.8632338559255 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 754.29998779296875, "invlev_up": 751.79998779296875, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_503_generated", "manhole_dn": "manhole_504_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385525.860647091642022, 5858475.8632338559255 ], [ 1385553.357332118786871, 5858517.404887572862208 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 751.70001220703125, "invlev_up": 751.79998779296875, "invlev_dn": 749.20001220703125, "manhole_up": "manhole_504_generated", "manhole_dn": "manhole_505_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385553.357332118786871, 5858517.404887572862208 ], [ 1385579.617479301057756, 5858559.686364834196866 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.70001220703125, "elevtn_dn": 751.70001220703125, "invlev_up": 749.20001220703125, "invlev_dn": 749.20001220703125, "manhole_up": "manhole_505_generated", "manhole_dn": "manhole_506_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385579.617479301057756, 5858559.686364834196866 ], [ 1385621.905693766893819, 5858585.068030893802643 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.70001220703125, "elevtn_dn": 750.9000244140625, "invlev_up": 749.20001220703125, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_506_generated", "manhole_dn": "manhole_507_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385621.905693766893819, 5858585.068030893802643 ], [ 1385664.027273919200525, 5858611.351026647724211 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 750.9000244140625, "invlev_up": 748.4000244140625, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_507_generated", "manhole_dn": "manhole_508_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385664.027273919200525, 5858611.351026647724211 ], [ 1385700.387205619364977, 5858645.507954810746014 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 750.9000244140625, "invlev_up": 748.4000244140625, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_508_generated", "manhole_dn": "manhole_509_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385700.387205619364977, 5858645.507954810746014 ], [ 1385734.601841112133116, 5858681.909404612146318 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 755.79998779296875, "invlev_up": 748.4000244140625, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_509_generated", "manhole_dn": "manhole_510_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385734.601841112133116, 5858681.909404612146318 ], [ 1385768.816476604901254, 5858718.310854412615299 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_510_generated", "manhole_dn": "manhole_511_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385768.816476604901254, 5858718.310854412615299 ], [ 1385802.200311921536922, 5858755.447309947572649 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_511_generated", "manhole_dn": "manhole_512_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385802.200311921536922, 5858755.447309947572649 ], [ 1385834.15946239954792, 5858793.844178703613579 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_21_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 765.0, "invlev_up": 753.79998779296875, "invlev_dn": 762.5, "manhole_up": "manhole_513_generated", "manhole_dn": "manhole_514_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385352.471788094611838, 5858398.70255031902343 ], [ 1385323.609449510695413, 5858430.098599229939282 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_21_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.0, "elevtn_dn": 765.0, "invlev_up": 762.5, "invlev_dn": 762.5, "manhole_up": "manhole_514_generated", "manhole_dn": "manhole_515_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385323.609449510695413, 5858430.098599229939282 ], [ 1385286.388775944709778, 5858419.306091710925102 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_21_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.0, "elevtn_dn": 758.9000244140625, "invlev_up": 762.5, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_515_generated", "manhole_dn": "manhole_516_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385286.388775944709778, 5858419.306091710925102 ], [ 1385252.458742934046313, 5858394.201654580421746 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_21_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 758.9000244140625, "invlev_up": 756.4000244140625, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_516_generated", "manhole_dn": "manhole_517_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385252.458742934046313, 5858394.201654580421746 ], [ 1385217.536378393415362, 5858369.72360460460186 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_21_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 756.79998779296875, "invlev_up": 756.4000244140625, "invlev_dn": 754.29998779296875, "manhole_up": "manhole_517_generated", "manhole_dn": "manhole_518_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385217.536378393415362, 5858369.72360460460186 ], [ 1385177.877519500209019, 5858363.975667187944055 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_23_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_23", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "manhole_up": "manhole_519_generated", "manhole_dn": "manhole_520_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384748.107251951703802, 5858475.46539437584579 ], [ 1384773.662756133358926, 5858482.028828926384449 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_23_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_23", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "manhole_up": "manhole_520_generated", "manhole_dn": "manhole_521_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384773.662756133358926, 5858482.028828926384449 ], [ 1384799.21826031524688, 5858488.592263477854431 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_24_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_24", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_24", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.9000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 760.4000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_522_generated", "manhole_dn": "manhole_523_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385831.554474999429658, 5858837.476550582796335 ], [ 1385834.933234154479578, 5858795.367517679929733 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_24_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_24", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_24", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 748.9000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_523_generated", "manhole_dn": "manhole_524_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385834.933234154479578, 5858795.367517679929733 ], [ 1385855.640895856311545, 5858836.135079927742481 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_25_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_25", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.79998779296875, "elevtn_dn": 791.20001220703125, "invlev_up": 784.29998779296875, "invlev_dn": 788.70001220703125, "manhole_up": "manhole_525_generated", "manhole_dn": "manhole_526_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385425.871741503709927, 5858809.522038951516151 ], [ 1385446.216239683330059, 5858844.397748519666493 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_25_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_25", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.20001220703125, "elevtn_dn": 791.20001220703125, "invlev_up": 788.70001220703125, "invlev_dn": 788.70001220703125, "manhole_up": "manhole_526_generated", "manhole_dn": "manhole_527_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385446.216239683330059, 5858844.397748519666493 ], [ 1385453.998638280900195, 5858886.437654017470777 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_25_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_25", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.20001220703125, "elevtn_dn": 783.0, "invlev_up": 788.70001220703125, "invlev_dn": 780.5, "manhole_up": "manhole_527_generated", "manhole_dn": "manhole_528_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385453.998638280900195, 5858886.437654017470777 ], [ 1385472.218053022632375, 5858925.273072509095073 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_26_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_26", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_26", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.9000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 760.4000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_522_generated", "manhole_dn": "manhole_524_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385831.554474999429658, 5858837.476550582796335 ], [ 1385855.640895856311545, 5858836.135079927742481 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_29_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_29", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_29", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_529_generated", "manhole_dn": "manhole_530_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385861.372513797832653, 5858893.832569030113518 ], [ 1385844.630084188189358, 5858865.848266057670116 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_29_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_29", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_29", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 762.9000244140625, "invlev_up": 757.20001220703125, "invlev_dn": 760.4000244140625, "manhole_up": "manhole_530_generated", "manhole_dn": "manhole_522_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385844.630084188189358, 5858865.848266057670116 ], [ 1385831.554474999429658, 5858837.476550582796335 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 769.4000244140625, "invlev_up": 766.9000244140625, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_531_generated", "manhole_dn": "manhole_532_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387137.22300889948383, 5858981.723106959834695 ], [ 1387148.04859330272302, 5859026.366797789931297 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 762.60003662109375, "invlev_up": 766.9000244140625, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_532_generated", "manhole_dn": "manhole_533_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387148.04859330272302, 5859026.366797789931297 ], [ 1387119.95937648974359, 5859056.934598693624139 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 762.60003662109375, "invlev_up": 760.10003662109375, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_533_generated", "manhole_dn": "manhole_534_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387119.95937648974359, 5859056.934598693624139 ], [ 1387074.832296247361228, 5859065.30100557859987 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 755.79998779296875, "invlev_up": 760.10003662109375, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_534_generated", "manhole_dn": "manhole_535_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387074.832296247361228, 5859065.30100557859987 ], [ 1387030.356415221933275, 5859076.86137125454843 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 772.4000244140625, "invlev_up": 753.29998779296875, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_535_generated", "manhole_dn": "manhole_536_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387030.356415221933275, 5859076.86137125454843 ], [ 1386986.427998587489128, 5859090.309648380614817 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 761.60003662109375, "invlev_up": 769.9000244140625, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_536_generated", "manhole_dn": "manhole_537_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386986.427998587489128, 5859090.309648380614817 ], [ 1386945.966695382725447, 5859111.788386604748666 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_537_generated", "manhole_dn": "manhole_538_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386945.966695382725447, 5859111.788386604748666 ], [ 1386905.77102447184734, 5859134.105928846634924 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_538_generated", "manhole_dn": "manhole_539_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386905.77102447184734, 5859134.105928846634924 ], [ 1386871.537448140559718, 5859162.609670763835311 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_539_generated", "manhole_dn": "manhole_540_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386871.537448140559718, 5859162.609670763835311 ], [ 1386921.106019288301468, 5859163.103915391489863 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 772.4000244140625, "invlev_up": 759.10003662109375, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_540_generated", "manhole_dn": "manhole_541_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386921.106019288301468, 5859163.103915391489863 ], [ 1386970.627896018791944, 5859161.624508504755795 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 772.4000244140625, "invlev_up": 769.9000244140625, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_541_generated", "manhole_dn": "manhole_542_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386970.627896018791944, 5859161.624508504755795 ], [ 1387019.993600395740941, 5859157.412991388700902 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 781.10003662109375, "invlev_up": 769.9000244140625, "invlev_dn": 778.60003662109375, "manhole_up": "manhole_542_generated", "manhole_dn": "manhole_543_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387019.993600395740941, 5859157.412991388700902 ], [ 1387069.191225855611265, 5859151.340004274621606 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 781.10003662109375, "elevtn_dn": 781.10003662109375, "invlev_up": 778.60003662109375, "invlev_dn": 778.60003662109375, "manhole_up": "manhole_543_generated", "manhole_dn": "manhole_544_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387069.191225855611265, 5859151.340004274621606 ], [ 1387118.547863835236058, 5859146.828392788767815 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 781.10003662109375, "elevtn_dn": 786.4000244140625, "invlev_up": 778.60003662109375, "invlev_dn": 783.9000244140625, "manhole_up": "manhole_544_generated", "manhole_dn": "manhole_545_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387118.547863835236058, 5859146.828392788767815 ], [ 1387167.916038708761334, 5859151.025294326245785 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.4000244140625, "elevtn_dn": 786.4000244140625, "invlev_up": 783.9000244140625, "invlev_dn": 783.9000244140625, "manhole_up": "manhole_545_generated", "manhole_dn": "manhole_546_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387167.916038708761334, 5859151.025294326245785 ], [ 1387217.282604865729809, 5859155.523034786805511 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.4000244140625, "elevtn_dn": 787.60003662109375, "invlev_up": 783.9000244140625, "invlev_dn": 785.10003662109375, "manhole_up": "manhole_546_generated", "manhole_dn": "manhole_547_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387217.282604865729809, 5859155.523034786805511 ], [ 1387266.649171022465453, 5859160.020775248296559 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.60003662109375, "elevtn_dn": 787.60003662109375, "invlev_up": 785.10003662109375, "invlev_dn": 785.10003662109375, "manhole_up": "manhole_547_generated", "manhole_dn": "manhole_548_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387266.649171022465453, 5859160.020775248296559 ], [ 1387315.831188223091885, 5859165.716172898188233 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.60003662109375, "elevtn_dn": 790.4000244140625, "invlev_up": 785.10003662109375, "invlev_dn": 787.9000244140625, "manhole_up": "manhole_548_generated", "manhole_dn": "manhole_549_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387315.831188223091885, 5859165.716172898188233 ], [ 1387364.261764668161049, 5859176.288154195994139 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 790.4000244140625, "elevtn_dn": 790.4000244140625, "invlev_up": 787.9000244140625, "invlev_dn": 787.9000244140625, "manhole_up": "manhole_549_generated", "manhole_dn": "manhole_550_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387364.261764668161049, 5859176.288154195994139 ], [ 1387411.186259990092367, 5859192.118345031514764 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 790.4000244140625, "elevtn_dn": 789.10003662109375, "invlev_up": 787.9000244140625, "invlev_dn": 786.60003662109375, "manhole_up": "manhole_550_generated", "manhole_dn": "manhole_551_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387411.186259990092367, 5859192.118345031514764 ], [ 1387455.544592748628929, 5859213.906051598489285 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 789.10003662109375, "elevtn_dn": 817.20001220703125, "invlev_up": 786.60003662109375, "invlev_dn": 814.70001220703125, "manhole_up": "manhole_551_generated", "manhole_dn": "manhole_552_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387455.544592748628929, 5859213.906051598489285 ], [ 1387490.610425172373652, 5859248.94134864397347 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 817.20001220703125, "elevtn_dn": 818.20001220703125, "invlev_up": 814.70001220703125, "invlev_dn": 815.70001220703125, "manhole_up": "manhole_552_generated", "manhole_dn": "manhole_553_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387490.610425172373652, 5859248.94134864397347 ], [ 1387525.979065561201423, 5859283.669168318621814 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.20001220703125, "elevtn_dn": 818.20001220703125, "invlev_up": 815.70001220703125, "invlev_dn": 815.70001220703125, "manhole_up": "manhole_553_generated", "manhole_dn": "manhole_554_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387525.979065561201423, 5859283.669168318621814 ], [ 1387563.532416822388768, 5859316.0270627560094 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.20001220703125, "elevtn_dn": 802.79998779296875, "invlev_up": 815.70001220703125, "invlev_dn": 800.29998779296875, "manhole_up": "manhole_554_generated", "manhole_dn": "manhole_555_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387563.532416822388768, 5859316.0270627560094 ], [ 1387601.085768083808944, 5859348.384957193396986 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.79998779296875, "elevtn_dn": 837.70001220703125, "invlev_up": 800.29998779296875, "invlev_dn": 835.20001220703125, "manhole_up": "manhole_555_generated", "manhole_dn": "manhole_556_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387601.085768083808944, 5859348.384957193396986 ], [ 1387638.639119345229119, 5859380.742851630784571 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 837.70001220703125, "elevtn_dn": 837.70001220703125, "invlev_up": 835.20001220703125, "invlev_dn": 835.20001220703125, "manhole_up": "manhole_556_generated", "manhole_dn": "manhole_557_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387638.639119345229119, 5859380.742851630784571 ], [ 1387676.192470606416464, 5859413.100746068172157 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 837.70001220703125, "elevtn_dn": 828.79998779296875, "invlev_up": 835.20001220703125, "invlev_dn": 826.29998779296875, "manhole_up": "manhole_557_generated", "manhole_dn": "manhole_558_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387676.192470606416464, 5859413.100746068172157 ], [ 1387713.745821867836639, 5859445.45864050462842 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 828.79998779296875, "elevtn_dn": 828.79998779296875, "invlev_up": 826.29998779296875, "invlev_dn": 826.29998779296875, "manhole_up": "manhole_558_generated", "manhole_dn": "manhole_559_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387713.745821867836639, 5859445.45864050462842 ], [ 1387750.394377880264074, 5859478.825171477161348 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 828.79998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 826.29998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_559_generated", "manhole_dn": "manhole_560_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387750.394377880264074, 5859478.825171477161348 ], [ 1387786.626276910537854, 5859512.656178202480078 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 851.79998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_560_generated", "manhole_dn": "manhole_561_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387786.626276910537854, 5859512.656178202480078 ], [ 1387822.858175940578803, 5859546.487184926867485 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 851.79998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_561_generated", "manhole_dn": "manhole_562_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387822.858175940578803, 5859546.487184926867485 ], [ 1387850.662340233800933, 5859586.980695966631174 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 891.20001220703125, "invlev_up": 851.79998779296875, "invlev_dn": 888.70001220703125, "manhole_up": "manhole_562_generated", "manhole_dn": "manhole_563_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387850.662340233800933, 5859586.980695966631174 ], [ 1387868.193221996771172, 5859633.330900657922029 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.20001220703125, "elevtn_dn": 876.20001220703125, "invlev_up": 888.70001220703125, "invlev_dn": 873.70001220703125, "manhole_up": "manhole_563_generated", "manhole_dn": "manhole_564_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387868.193221996771172, 5859633.330900657922029 ], [ 1387885.535610173596069, 5859679.769344814121723 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 876.20001220703125, "elevtn_dn": 876.20001220703125, "invlev_up": 873.70001220703125, "invlev_dn": 873.70001220703125, "manhole_up": "manhole_564_generated", "manhole_dn": "manhole_565_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387885.535610173596069, 5859679.769344814121723 ], [ 1387902.854485532967374, 5859726.216552678495646 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 876.20001220703125, "elevtn_dn": 898.29998779296875, "invlev_up": 873.70001220703125, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_565_generated", "manhole_dn": "manhole_566_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387902.854485532967374, 5859726.216552678495646 ], [ 1387920.137465380365029, 5859772.67713953461498 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 898.29998779296875, "invlev_up": 895.79998779296875, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_566_generated", "manhole_dn": "manhole_567_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387920.137465380365029, 5859772.67713953461498 ], [ 1387937.420445227529854, 5859819.137726389802992 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 898.29998779296875, "invlev_up": 895.79998779296875, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_567_generated", "manhole_dn": "manhole_568_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387937.420445227529854, 5859819.137726389802992 ], [ 1387948.863530882401392, 5859867.082766367122531 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 918.5, "invlev_up": 895.79998779296875, "invlev_dn": 916.0, "manhole_up": "manhole_568_generated", "manhole_dn": "manhole_569_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387948.863530882401392, 5859867.082766367122531 ], [ 1387950.013254075078294, 5859916.565449987538159 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 918.5, "invlev_up": 916.0, "invlev_dn": 916.0, "manhole_up": "manhole_569_generated", "manhole_dn": "manhole_570_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387950.013254075078294, 5859916.565449987538159 ], [ 1387947.430782878771424, 5859966.047936389222741 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 918.5, "invlev_up": 916.0, "invlev_dn": 916.0, "manhole_up": "manhole_570_generated", "manhole_dn": "manhole_571_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387947.430782878771424, 5859966.047936389222741 ], [ 1387943.997958281077445, 5860015.499966060742736 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 948.60003662109375, "invlev_up": 916.0, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_571_generated", "manhole_dn": "manhole_572_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387943.997958281077445, 5860015.499966060742736 ], [ 1387940.565133683150634, 5860064.951995733194053 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 948.60003662109375, "invlev_up": 946.10003662109375, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_572_generated", "manhole_dn": "manhole_573_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.565133683150634, 5860064.951995733194053 ], [ 1387945.371777657186612, 5860113.959104515612125 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 948.60003662109375, "invlev_up": 946.10003662109375, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_573_generated", "manhole_dn": "manhole_574_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387945.371777657186612, 5860113.959104515612125 ], [ 1387964.117816498270258, 5860159.736532494425774 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 940.5, "invlev_up": 946.10003662109375, "invlev_dn": 938.0, "manhole_up": "manhole_574_generated", "manhole_dn": "manhole_575_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387964.117816498270258, 5860159.736532494425774 ], [ 1387984.093857799191028, 5860205.104420888237655 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 940.5, "invlev_up": 938.0, "invlev_dn": 938.0, "manhole_up": "manhole_575_generated", "manhole_dn": "manhole_576_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387984.093857799191028, 5860205.104420888237655 ], [ 1388004.069899099878967, 5860250.472309282049537 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 940.5, "invlev_up": 938.0, "invlev_dn": 938.0, "manhole_up": "manhole_576_generated", "manhole_dn": "manhole_577_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388004.069899099878967, 5860250.472309282049537 ], [ 1388027.68692572391592, 5860293.896034284494817 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 971.70001220703125, "invlev_up": 938.0, "invlev_dn": 969.20001220703125, "manhole_up": "manhole_577_generated", "manhole_dn": "manhole_578_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388027.68692572391592, 5860293.896034284494817 ], [ 1388060.096315970877185, 5860331.348726416006684 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 971.70001220703125, "elevtn_dn": 935.5, "invlev_up": 969.20001220703125, "invlev_dn": 933.0, "manhole_up": "manhole_578_generated", "manhole_dn": "manhole_579_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388060.096315970877185, 5860331.348726416006684 ], [ 1388092.967688721138984, 5860368.453448176383972 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 935.5, "invlev_up": 933.0, "invlev_dn": 933.0, "manhole_up": "manhole_579_generated", "manhole_dn": "manhole_580_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388092.967688721138984, 5860368.453448176383972 ], [ 1388119.020827289205045, 5860410.510251956991851 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 949.9000244140625, "invlev_up": 933.0, "invlev_dn": 947.4000244140625, "manhole_up": "manhole_580_generated", "manhole_dn": "manhole_581_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388119.020827289205045, 5860410.510251956991851 ], [ 1388143.407622833969072, 5860453.667774203233421 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 949.9000244140625, "elevtn_dn": 924.60003662109375, "invlev_up": 947.4000244140625, "invlev_dn": 922.10003662109375, "manhole_up": "manhole_581_generated", "manhole_dn": "manhole_582_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388143.407622833969072, 5860453.667774203233421 ], [ 1388167.794418378733099, 5860496.82529644947499 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 924.60003662109375, "elevtn_dn": 924.60003662109375, "invlev_up": 922.10003662109375, "invlev_dn": 922.10003662109375, "manhole_up": "manhole_582_generated", "manhole_dn": "manhole_583_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388167.794418378733099, 5860496.82529644947499 ], [ 1388187.41186453984119, 5860542.097804954275489 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 924.60003662109375, "elevtn_dn": 942.4000244140625, "invlev_up": 922.10003662109375, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_583_generated", "manhole_dn": "manhole_584_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388187.41186453984119, 5860542.097804954275489 ], [ 1388193.385166377527639, 5860591.251542154699564 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 942.4000244140625, "invlev_up": 939.9000244140625, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_584_generated", "manhole_dn": "manhole_585_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388193.385166377527639, 5860591.251542154699564 ], [ 1388198.812296225922182, 5860640.524595490656793 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 942.4000244140625, "invlev_up": 939.9000244140625, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_585_generated", "manhole_dn": "manhole_586_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388198.812296225922182, 5860640.524595490656793 ], [ 1388204.239426074549556, 5860689.7976488256827 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 955.0, "invlev_up": 939.9000244140625, "invlev_dn": 952.5, "manhole_up": "manhole_586_generated", "manhole_dn": "manhole_587_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388204.239426074549556, 5860689.7976488256827 ], [ 1388184.484932377934456, 5860730.700381714850664 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E48", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_587_generated", "manhole_dn": "manhole_588_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388184.484932377934456, 5860730.700381714850664 ], [ 1388159.550175313837826, 5860759.392759991809726 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E49", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_588_generated", "manhole_dn": "manhole_589_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388159.550175313837826, 5860759.392759991809726 ], [ 1388171.988544700434431, 5860807.377908634953201 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E50", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_589_generated", "manhole_dn": "manhole_590_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388171.988544700434431, 5860807.377908634953201 ], [ 1388215.013825689908117, 5860825.214942933060229 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E51", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 941.10003662109375, "invlev_up": 952.5, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_590_generated", "manhole_dn": "manhole_591_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388215.013825689908117, 5860825.214942933060229 ], [ 1388264.397385431453586, 5860829.298032846301794 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E52", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_591_generated", "manhole_dn": "manhole_592_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388264.397385431453586, 5860829.298032846301794 ], [ 1388313.062299854354933, 5860837.304878970608115 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E53", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 937.5, "invlev_up": 938.60003662109375, "invlev_dn": 935.0, "manhole_up": "manhole_592_generated", "manhole_dn": "manhole_593_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388313.062299854354933, 5860837.304878970608115 ], [ 1388360.993895401246846, 5860849.948045967146754 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E54", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.5, "elevtn_dn": 937.5, "invlev_up": 935.0, "invlev_dn": 935.0, "manhole_up": "manhole_593_generated", "manhole_dn": "manhole_594_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388360.993895401246846, 5860849.948045967146754 ], [ 1388408.925490947905928, 5860862.591212964616716 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E55", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.5, "elevtn_dn": 937.60003662109375, "invlev_up": 935.0, "invlev_dn": 935.10003662109375, "manhole_up": "manhole_594_generated", "manhole_dn": "manhole_595_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388408.925490947905928, 5860862.591212964616716 ], [ 1388458.220990223577246, 5860866.957201769575477 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E56", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.60003662109375, "elevtn_dn": 937.60003662109375, "invlev_up": 935.10003662109375, "invlev_dn": 935.10003662109375, "manhole_up": "manhole_595_generated", "manhole_dn": "manhole_596_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388458.220990223577246, 5860866.957201769575477 ], [ 1388507.336333080893382, 5860873.218384950421751 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E57", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.60003662109375, "elevtn_dn": 941.20001220703125, "invlev_up": 935.10003662109375, "invlev_dn": 938.70001220703125, "manhole_up": "manhole_596_generated", "manhole_dn": "manhole_597_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388507.336333080893382, 5860873.218384950421751 ], [ 1388556.215695114107803, 5860881.470384138636291 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E58", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.20001220703125, "elevtn_dn": 941.20001220703125, "invlev_up": 938.70001220703125, "invlev_dn": 938.70001220703125, "manhole_up": "manhole_597_generated", "manhole_dn": "manhole_598_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388556.215695114107803, 5860881.470384138636291 ], [ 1388604.556662159739062, 5860892.361969010904431 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E59", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.20001220703125, "elevtn_dn": 943.10003662109375, "invlev_up": 938.70001220703125, "invlev_dn": 940.60003662109375, "manhole_up": "manhole_598_generated", "manhole_dn": "manhole_599_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388604.556662159739062, 5860892.361969010904431 ], [ 1388653.59940263046883, 5860897.15789801068604 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E60", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 943.10003662109375, "elevtn_dn": 943.10003662109375, "invlev_up": 940.60003662109375, "invlev_dn": 940.60003662109375, "manhole_up": "manhole_599_generated", "manhole_dn": "manhole_600_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388653.59940263046883, 5860897.15789801068604 ], [ 1388700.080393208190799, 5860881.090511013753712 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E61", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 943.10003662109375, "elevtn_dn": 946.10003662109375, "invlev_up": 940.60003662109375, "invlev_dn": 943.60003662109375, "manhole_up": "manhole_600_generated", "manhole_dn": "manhole_601_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388700.080393208190799, 5860881.090511013753712 ], [ 1388732.687003659084439, 5860844.794781206175685 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E62", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 946.10003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 943.60003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_601_generated", "manhole_dn": "manhole_602_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388732.687003659084439, 5860844.794781206175685 ], [ 1388755.953327334951609, 5860801.023035684600472 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E63", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 950.10003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_602_generated", "manhole_dn": "manhole_603_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388755.953327334951609, 5860801.023035684600472 ], [ 1388778.23369869007729, 5860756.84024004638195 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E64", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 950.10003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_603_generated", "manhole_dn": "manhole_604_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388778.23369869007729, 5860756.84024004638195 ], [ 1388792.950793598080054, 5860709.504263866692781 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E65", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 953.79998779296875, "invlev_up": 950.10003662109375, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_604_generated", "manhole_dn": "manhole_605_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388792.950793598080054, 5860709.504263866692781 ], [ 1388807.667888506315649, 5860662.168287687934935 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E66", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_605_generated", "manhole_dn": "manhole_606_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388807.667888506315649, 5860662.168287687934935 ], [ 1388819.224422588944435, 5860613.968191100284457 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E67", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 955.70001220703125, "invlev_up": 951.29998779296875, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_606_generated", "manhole_dn": "manhole_607_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388819.224422588944435, 5860613.968191100284457 ], [ 1388830.63825476472266, 5860565.72907877061516 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E68", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_607_generated", "manhole_dn": "manhole_608_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388830.63825476472266, 5860565.72907877061516 ], [ 1388842.052086940500885, 5860517.489966440014541 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E69", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_608_generated", "manhole_dn": "manhole_609_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388842.052086940500885, 5860517.489966440014541 ], [ 1388862.77624000934884, 5860472.578981296159327 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E70", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 964.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_609_generated", "manhole_dn": "manhole_610_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388862.77624000934884, 5860472.578981296159327 ], [ 1388884.529400010826066, 5860428.03588358964771 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E71", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 951.29998779296875, "invlev_up": 962.20001220703125, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_610_generated", "manhole_dn": "manhole_611_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388884.529400010826066, 5860428.03588358964771 ], [ 1388906.282637836178765, 5860383.492823889479041 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E72", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_611_generated", "manhole_dn": "manhole_612_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388906.282637836178765, 5860383.492823889479041 ], [ 1388933.946375871310011, 5860342.419800435192883 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E73", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_612_generated", "manhole_dn": "manhole_613_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388933.946375871310011, 5860342.419800435192883 ], [ 1388962.240715913940221, 5860301.717001453973353 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 752.29998779296875, "invlev_up": 759.10003662109375, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_539_generated", "manhole_dn": "manhole_614_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386871.537448140559718, 5859162.609670763835311 ], [ 1386825.19834817154333, 5859175.156894122250378 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 752.29998779296875, "invlev_up": 749.79998779296875, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_614_generated", "manhole_dn": "manhole_615_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386825.19834817154333, 5859175.156894122250378 ], [ 1386779.333999397465959, 5859189.44842192158103 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 738.0, "invlev_up": 749.79998779296875, "invlev_dn": 735.5, "manhole_up": "manhole_615_generated", "manhole_dn": "manhole_616_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386779.333999397465959, 5859189.44842192158103 ], [ 1386733.445003136992455, 5859203.660136871039867 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 738.0, "invlev_up": 735.5, "invlev_dn": 735.5, "manhole_up": "manhole_616_generated", "manhole_dn": "manhole_617_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386733.445003136992455, 5859203.660136871039867 ], [ 1386687.508546756347641, 5859217.718167688697577 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 763.29998779296875, "invlev_up": 735.5, "invlev_dn": 760.79998779296875, "manhole_up": "manhole_617_generated", "manhole_dn": "manhole_618_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386687.508546756347641, 5859217.718167688697577 ], [ 1386641.572090375469998, 5859231.776198507286608 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 763.29998779296875, "elevtn_dn": 763.29998779296875, "invlev_up": 760.79998779296875, "invlev_dn": 760.79998779296875, "manhole_up": "manhole_618_generated", "manhole_dn": "manhole_619_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386641.572090375469998, 5859231.776198507286608 ], [ 1386595.451642262749374, 5859245.168246414512396 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 763.29998779296875, "elevtn_dn": 754.60003662109375, "invlev_up": 760.79998779296875, "invlev_dn": 752.10003662109375, "manhole_up": "manhole_619_generated", "manhole_dn": "manhole_620_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386595.451642262749374, 5859245.168246414512396 ], [ 1386548.813360751140863, 5859256.685926430858672 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.60003662109375, "elevtn_dn": 754.60003662109375, "invlev_up": 752.10003662109375, "invlev_dn": 752.10003662109375, "manhole_up": "manhole_620_generated", "manhole_dn": "manhole_621_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386548.813360751140863, 5859256.685926430858672 ], [ 1386502.175079239532351, 5859268.203606447204947 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.60003662109375, "elevtn_dn": 742.5, "invlev_up": 752.10003662109375, "invlev_dn": 740.0, "manhole_up": "manhole_621_generated", "manhole_dn": "manhole_622_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386502.175079239532351, 5859268.203606447204947 ], [ 1386455.354356503346935, 5859278.943273726850748 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 742.5, "invlev_up": 740.0, "invlev_dn": 740.0, "manhole_up": "manhole_622_generated", "manhole_dn": "manhole_623_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386455.354356503346935, 5859278.943273726850748 ], [ 1386408.879239794565365, 5859290.671229789964855 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 717.60003662109375, "invlev_up": 740.0, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_623_generated", "manhole_dn": "manhole_624_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386408.879239794565365, 5859290.671229789964855 ], [ 1386364.691368696978316, 5859309.518465746194124 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 717.60003662109375, "invlev_up": 715.10003662109375, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_624_generated", "manhole_dn": "manhole_625_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386364.691368696978316, 5859309.518465746194124 ], [ 1386320.503497599391267, 5859328.365701701492071 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 711.0, "invlev_up": 715.10003662109375, "invlev_dn": 708.5, "manhole_up": "manhole_625_generated", "manhole_dn": "manhole_626_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386320.503497599391267, 5859328.365701701492071 ], [ 1386273.173811787506565, 5859335.36546028777957 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 953.70001220703125, "invlev_up": 948.79998779296875, "invlev_dn": 951.20001220703125, "manhole_up": "manhole_10_generated", "manhole_dn": "manhole_627_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388946.301100668497384, 5860414.883977899327874 ], [ 1388922.246059404918924, 5860458.418739438988268 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.70001220703125, "elevtn_dn": 953.70001220703125, "invlev_up": 951.20001220703125, "invlev_dn": 951.20001220703125, "manhole_up": "manhole_627_generated", "manhole_dn": "manhole_628_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388922.246059404918924, 5860458.418739438988268 ], [ 1388900.295977992936969, 5860503.075897979550064 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 951.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_628_generated", "manhole_dn": "manhole_629_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388900.295977992936969, 5860503.075897979550064 ], [ 1388878.345896581187844, 5860547.733056520111859 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 953.79998779296875, "invlev_up": 953.20001220703125, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_629_generated", "manhole_dn": "manhole_630_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388878.345896581187844, 5860547.733056520111859 ], [ 1388856.887740465346724, 5860592.570927501656115 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_630_generated", "manhole_dn": "manhole_631_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388856.887740465346724, 5860592.570927501656115 ], [ 1388853.076019846601412, 5860641.795407227240503 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_631_generated", "manhole_dn": "manhole_632_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388853.076019846601412, 5860641.795407227240503 ], [ 1388856.119826921960339, 5860691.462329030036926 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 952.5, "invlev_up": 951.29998779296875, "invlev_dn": 950.0, "manhole_up": "manhole_632_generated", "manhole_dn": "manhole_633_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388856.119826921960339, 5860691.462329030036926 ], [ 1388859.163633997086436, 5860741.12925083283335 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.5, "elevtn_dn": 952.5, "invlev_up": 950.0, "invlev_dn": 950.0, "manhole_up": "manhole_633_generated", "manhole_dn": "manhole_634_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388859.163633997086436, 5860741.12925083283335 ], [ 1388862.207441072445363, 5860790.796172635629773 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.5, "elevtn_dn": 945.5, "invlev_up": 950.0, "invlev_dn": 943.0, "manhole_up": "manhole_634_generated", "manhole_dn": "manhole_635_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388862.207441072445363, 5860790.796172635629773 ], [ 1388866.356326055014506, 5860840.344227194786072 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 945.5, "invlev_up": 943.0, "invlev_dn": 943.0, "manhole_up": "manhole_635_generated", "manhole_dn": "manhole_636_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388866.356326055014506, 5860840.344227194786072 ], [ 1388873.944740658160299, 5860889.522310186177492 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 945.5, "invlev_up": 943.0, "invlev_dn": 943.0, "manhole_up": "manhole_636_generated", "manhole_dn": "manhole_637_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388873.944740658160299, 5860889.522310186177492 ], [ 1388883.17427325528115, 5860938.398467163555324 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 937.4000244140625, "invlev_up": 943.0, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_637_generated", "manhole_dn": "manhole_638_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388883.17427325528115, 5860938.398467163555324 ], [ 1388890.216840920504183, 5860987.212368851527572 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 937.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_638_generated", "manhole_dn": "manhole_639_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388890.216840920504183, 5860987.212368851527572 ], [ 1388884.322194910608232, 5861036.62209493201226 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 937.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_639_generated", "manhole_dn": "manhole_640_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388884.322194910608232, 5861036.62209493201226 ], [ 1388878.427548900712281, 5861086.031821011565626 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_640_generated", "manhole_dn": "manhole_641_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388878.427548900712281, 5861086.031821011565626 ], [ 1388872.532902890816331, 5861135.441547092050314 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 927.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_641_generated", "manhole_dn": "manhole_642_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388872.532902890816331, 5861135.441547092050314 ], [ 1388866.63825688092038, 5861184.851273172535002 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 927.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_642_generated", "manhole_dn": "manhole_643_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388866.63825688092038, 5861184.851273172535002 ], [ 1388854.620840607210994, 5861232.489912945777178 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 926.60003662109375, "invlev_up": 927.9000244140625, "invlev_dn": 924.10003662109375, "manhole_up": "manhole_643_generated", "manhole_dn": "manhole_644_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388854.620840607210994, 5861232.489912945777178 ], [ 1388833.22756120422855, 5861277.416469449177384 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 926.60003662109375, "elevtn_dn": 926.60003662109375, "invlev_up": 924.10003662109375, "invlev_dn": 924.10003662109375, "manhole_up": "manhole_644_generated", "manhole_dn": "manhole_645_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388833.22756120422855, 5861277.416469449177384 ], [ 1388811.834281801246107, 5861322.343025953508914 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 926.60003662109375, "elevtn_dn": 931.10003662109375, "invlev_up": 924.10003662109375, "invlev_dn": 928.60003662109375, "manhole_up": "manhole_645_generated", "manhole_dn": "manhole_646_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388811.834281801246107, 5861322.343025953508914 ], [ 1388790.441002398030832, 5861367.26958245690912 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 931.10003662109375, "elevtn_dn": 922.20001220703125, "invlev_up": 928.60003662109375, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_646_generated", "manhole_dn": "manhole_647_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388790.441002398030832, 5861367.26958245690912 ], [ 1388769.047722995048389, 5861412.196138960309327 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 922.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_647_generated", "manhole_dn": "manhole_648_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388769.047722995048389, 5861412.196138960309327 ], [ 1388747.654443592065945, 5861457.122695464640856 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 922.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_648_generated", "manhole_dn": "manhole_649_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388747.654443592065945, 5861457.122695464640856 ], [ 1388725.026126575190574, 5861501.410491958260536 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_649_generated", "manhole_dn": "manhole_650_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388725.026126575190574, 5861501.410491958260536 ], [ 1388700.725248141447082, 5861544.833241644315422 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_650_generated", "manhole_dn": "manhole_651_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388700.725248141447082, 5861544.833241644315422 ], [ 1388676.42436970770359, 5861588.255991329438984 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_651_generated", "manhole_dn": "manhole_652_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388676.42436970770359, 5861588.255991329438984 ], [ 1388632.324464634526521, 5861606.441272142343223 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 898.4000244140625, "invlev_up": 897.70001220703125, "invlev_dn": 895.9000244140625, "manhole_up": "manhole_652_generated", "manhole_dn": "manhole_653_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388632.324464634526521, 5861606.441272142343223 ], [ 1388583.463808472501114, 5861611.105615227483213 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.4000244140625, "elevtn_dn": 898.4000244140625, "invlev_up": 895.9000244140625, "invlev_dn": 895.9000244140625, "manhole_up": "manhole_653_generated", "manhole_dn": "manhole_654_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388583.463808472501114, 5861611.105615227483213 ], [ 1388534.764012826373801, 5861604.222017968073487 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.4000244140625, "elevtn_dn": 903.60003662109375, "invlev_up": 895.9000244140625, "invlev_dn": 901.10003662109375, "manhole_up": "manhole_654_generated", "manhole_dn": "manhole_655_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388534.764012826373801, 5861604.222017968073487 ], [ 1388489.566489090910181, 5861583.40731808822602 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 903.60003662109375, "elevtn_dn": 903.60003662109375, "invlev_up": 901.10003662109375, "invlev_dn": 901.10003662109375, "manhole_up": "manhole_655_generated", "manhole_dn": "manhole_656_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388489.566489090910181, 5861583.40731808822602 ], [ 1388444.204915680922568, 5861563.162508152425289 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 903.60003662109375, "elevtn_dn": 906.4000244140625, "invlev_up": 901.10003662109375, "invlev_dn": 903.9000244140625, "manhole_up": "manhole_656_generated", "manhole_dn": "manhole_657_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388444.204915680922568, 5861563.162508152425289 ], [ 1388394.858231473481283, 5861556.761520680040121 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 906.4000244140625, "elevtn_dn": 906.4000244140625, "invlev_up": 903.9000244140625, "invlev_dn": 903.9000244140625, "manhole_up": "manhole_657_generated", "manhole_dn": "manhole_658_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388394.858231473481283, 5861556.761520680040121 ], [ 1388350.680838279658929, 5861570.408674017526209 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 906.4000244140625, "elevtn_dn": 900.20001220703125, "invlev_up": 903.9000244140625, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_658_generated", "manhole_dn": "manhole_659_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388350.680838279658929, 5861570.408674017526209 ], [ 1388310.581732882419601, 5861599.872713611461222 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_659_generated", "manhole_dn": "manhole_660_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388310.581732882419601, 5861599.872713611461222 ], [ 1388271.039625711739063, 5861629.969603477045894 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 890.0, "invlev_up": 897.70001220703125, "invlev_dn": 887.5, "manhole_up": "manhole_660_generated", "manhole_dn": "manhole_661_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388271.039625711739063, 5861629.969603477045894 ], [ 1388236.722210306907073, 5861666.002683873288333 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 890.0, "invlev_up": 887.5, "invlev_dn": 887.5, "manhole_up": "manhole_661_generated", "manhole_dn": "manhole_662_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388236.722210306907073, 5861666.002683873288333 ], [ 1388202.404794902307913, 5861702.035764269530773 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 890.0, "invlev_up": 887.5, "invlev_dn": 887.5, "manhole_up": "manhole_662_generated", "manhole_dn": "manhole_663_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388202.404794902307913, 5861702.035764269530773 ], [ 1388168.087379497475922, 5861738.068844665773213 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 885.9000244140625, "invlev_up": 887.5, "invlev_dn": 883.4000244140625, "manhole_up": "manhole_663_generated", "manhole_dn": "manhole_664_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388168.087379497475922, 5861738.068844665773213 ], [ 1388133.769964092643932, 5861774.101925062015653 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 885.9000244140625, "elevtn_dn": 874.0, "invlev_up": 883.4000244140625, "invlev_dn": 871.5, "manhole_up": "manhole_664_generated", "manhole_dn": "manhole_665_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388133.769964092643932, 5861774.101925062015653 ], [ 1388099.452548687811941, 5861810.13500545732677 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 874.0, "elevtn_dn": 874.0, "invlev_up": 871.5, "invlev_dn": 871.5, "manhole_up": "manhole_665_generated", "manhole_dn": "manhole_666_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388099.452548687811941, 5861810.13500545732677 ], [ 1388065.135133283212781, 5861846.16808585356921 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 874.0, "elevtn_dn": 862.20001220703125, "invlev_up": 871.5, "invlev_dn": 859.70001220703125, "manhole_up": "manhole_666_generated", "manhole_dn": "manhole_667_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388065.135133283212781, 5861846.16808585356921 ], [ 1388022.995196633273736, 5861866.899685021489859 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 862.20001220703125, "elevtn_dn": 862.20001220703125, "invlev_up": 859.70001220703125, "invlev_dn": 859.70001220703125, "manhole_up": "manhole_667_generated", "manhole_dn": "manhole_668_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388022.995196633273736, 5861866.899685021489859 ], [ 1387973.690499771386385, 5861873.616436487063766 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 862.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 859.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_668_generated", "manhole_dn": "manhole_669_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387973.690499771386385, 5861873.616436487063766 ], [ 1387924.470484273741022, 5861880.90659652557224 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_669_generated", "manhole_dn": "manhole_670_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387924.470484273741022, 5861880.90659652557224 ], [ 1387877.962616891367361, 5861896.157046243548393 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_670_generated", "manhole_dn": "manhole_671_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387877.962616891367361, 5861896.157046243548393 ], [ 1387917.070526217576116, 5861911.915829903446138 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_671_generated", "manhole_dn": "manhole_672_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387917.070526217576116, 5861911.915829903446138 ], [ 1387966.654667611001059, 5861916.096835186704993 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 846.29998779296875, "invlev_up": 856.70001220703125, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_672_generated", "manhole_dn": "manhole_673_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387966.654667611001059, 5861916.096835186704993 ], [ 1388016.318005530629307, 5861919.063731476664543 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 850.10003662109375, "invlev_up": 843.79998779296875, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_673_generated", "manhole_dn": "manhole_674_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388016.318005530629307, 5861919.063731476664543 ], [ 1388066.025120510486886, 5861921.359510923735797 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E48", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 850.10003662109375, "invlev_up": 847.60003662109375, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_674_generated", "manhole_dn": "manhole_675_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388066.025120510486886, 5861921.359510923735797 ], [ 1388115.732235490344465, 5861923.655290370807052 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E49", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 849.0, "invlev_up": 847.60003662109375, "invlev_dn": 846.5, "manhole_up": "manhole_675_generated", "manhole_dn": "manhole_676_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388115.732235490344465, 5861923.655290370807052 ], [ 1388161.130695321131498, 5861931.457672152668238 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E50", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 849.0, "elevtn_dn": 850.10003662109375, "invlev_up": 846.5, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_676_generated", "manhole_dn": "manhole_677_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388161.130695321131498, 5861931.457672152668238 ], [ 1388139.871223766123876, 5861964.082641129381955 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E51", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 850.10003662109375, "invlev_up": 847.60003662109375, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_677_generated", "manhole_dn": "manhole_678_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388139.871223766123876, 5861964.082641129381955 ], [ 1388090.726845995755866, 5861957.769498392008245 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E52", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 846.29998779296875, "invlev_up": 847.60003662109375, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_678_generated", "manhole_dn": "manhole_679_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388090.726845995755866, 5861957.769498392008245 ], [ 1388049.339104855433106, 5861983.736727176234126 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E53", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 846.29998779296875, "invlev_up": 843.79998779296875, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_679_generated", "manhole_dn": "manhole_680_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388049.339104855433106, 5861983.736727176234126 ], [ 1388024.713075590552762, 5862026.975905770435929 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E54", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 846.29998779296875, "invlev_up": 843.79998779296875, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_680_generated", "manhole_dn": "manhole_681_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388024.713075590552762, 5862026.975905770435929 ], [ 1387980.016218039905652, 5862047.702198376879096 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E55", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 793.5, "invlev_up": 843.79998779296875, "invlev_dn": 791.0, "manhole_up": "manhole_681_generated", "manhole_dn": "manhole_682_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387980.016218039905652, 5862047.702198376879096 ], [ 1387931.90673128189519, 5862056.853296543471515 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E56", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.5, "elevtn_dn": 793.5, "invlev_up": 791.0, "invlev_dn": 791.0, "manhole_up": "manhole_682_generated", "manhole_dn": "manhole_683_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387931.90673128189519, 5862056.853296543471515 ], [ 1387882.187313467729837, 5862058.865105460397899 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E57", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.5, "elevtn_dn": 793.20001220703125, "invlev_up": 791.0, "invlev_dn": 790.70001220703125, "manhole_up": "manhole_683_generated", "manhole_dn": "manhole_684_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387882.187313467729837, 5862058.865105460397899 ], [ 1387832.722497318405658, 5862057.3410848621279 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E58", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.20001220703125, "elevtn_dn": 830.29998779296875, "invlev_up": 790.70001220703125, "invlev_dn": 827.79998779296875, "manhole_up": "manhole_684_generated", "manhole_dn": "manhole_685_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387832.722497318405658, 5862057.3410848621279 ], [ 1387783.80423084856011, 5862048.226750630885363 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E59", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.29998779296875, "elevtn_dn": 817.70001220703125, "invlev_up": 827.79998779296875, "invlev_dn": 815.20001220703125, "manhole_up": "manhole_685_generated", "manhole_dn": "manhole_686_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387783.80423084856011, 5862048.226750630885363 ], [ 1387734.885964378714561, 5862039.112416399642825 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E60", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 817.70001220703125, "elevtn_dn": 813.70001220703125, "invlev_up": 815.20001220703125, "invlev_dn": 811.20001220703125, "manhole_up": "manhole_686_generated", "manhole_dn": "manhole_687_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387734.885964378714561, 5862039.112416399642825 ], [ 1387685.967697908869013, 5862029.998082168400288 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E61", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 813.70001220703125, "elevtn_dn": 813.70001220703125, "invlev_up": 811.20001220703125, "invlev_dn": 811.20001220703125, "manhole_up": "manhole_687_generated", "manhole_dn": "manhole_688_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387685.967697908869013, 5862029.998082168400288 ], [ 1387637.036115845199674, 5862020.957140567712486 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E62", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 813.70001220703125, "elevtn_dn": 807.0, "invlev_up": 811.20001220703125, "invlev_dn": 804.5, "manhole_up": "manhole_688_generated", "manhole_dn": "manhole_689_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387637.036115845199674, 5862020.957140567712486 ], [ 1387588.033849656581879, 5862012.305794355459511 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E63", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.0, "elevtn_dn": 807.0, "invlev_up": 804.5, "invlev_dn": 804.5, "manhole_up": "manhole_689_generated", "manhole_dn": "manhole_690_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387588.033849656581879, 5862012.305794355459511 ], [ 1387539.031583468196914, 5862003.654448143206537 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E64", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.0, "elevtn_dn": 793.10003662109375, "invlev_up": 804.5, "invlev_dn": 790.60003662109375, "manhole_up": "manhole_690_generated", "manhole_dn": "manhole_691_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387539.031583468196914, 5862003.654448143206537 ], [ 1387490.029317279579118, 5861995.003101930953562 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E65", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.10003662109375, "elevtn_dn": 793.10003662109375, "invlev_up": 790.60003662109375, "invlev_dn": 790.60003662109375, "manhole_up": "manhole_691_generated", "manhole_dn": "manhole_692_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387490.029317279579118, 5861995.003101930953562 ], [ 1387440.720367865404114, 5861989.908138634636998 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E66", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.10003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 790.60003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_692_generated", "manhole_dn": "manhole_693_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387440.720367865404114, 5861989.908138634636998 ], [ 1387390.960446665296331, 5861990.042768024839461 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E67", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_693_generated", "manhole_dn": "manhole_694_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387390.960446665296331, 5861990.042768024839461 ], [ 1387341.200525465421379, 5861990.177397414110601 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E68", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 749.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 747.10003662109375, "manhole_up": "manhole_694_generated", "manhole_dn": "manhole_695_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387341.200525465421379, 5861990.177397414110601 ], [ 1387291.440604265546426, 5861990.312026804313064 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E69", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 749.60003662109375, "elevtn_dn": 749.60003662109375, "invlev_up": 747.10003662109375, "invlev_dn": 747.10003662109375, "manhole_up": "manhole_695_generated", "manhole_dn": "manhole_696_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387291.440604265546426, 5861990.312026804313064 ], [ 1387246.706285298336297, 5861974.212805554270744 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E70", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 749.60003662109375, "elevtn_dn": 747.0, "invlev_up": 747.10003662109375, "invlev_dn": 744.5, "manhole_up": "manhole_696_generated", "manhole_dn": "manhole_697_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387246.706285298336297, 5861974.212805554270744 ], [ 1387205.725988702848554, 5861945.987228964455426 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E71", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.0, "elevtn_dn": 771.79998779296875, "invlev_up": 744.5, "invlev_dn": 769.29998779296875, "manhole_up": "manhole_697_generated", "manhole_dn": "manhole_698_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387205.725988702848554, 5861945.987228964455426 ], [ 1387164.745692107127979, 5861917.761652374640107 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E72", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.79998779296875, "elevtn_dn": 764.10003662109375, "invlev_up": 769.29998779296875, "invlev_dn": 761.60003662109375, "manhole_up": "manhole_698_generated", "manhole_dn": "manhole_699_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387164.745692107127979, 5861917.761652374640107 ], [ 1387115.569933785125613, 5861911.215812381356955 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E73", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.10003662109375, "elevtn_dn": 764.10003662109375, "invlev_up": 761.60003662109375, "invlev_dn": 761.60003662109375, "manhole_up": "manhole_699_generated", "manhole_dn": "manhole_700_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387115.569933785125613, 5861911.215812381356955 ], [ 1387066.165866439929232, 5861905.273926095105708 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E74", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.10003662109375, "elevtn_dn": 747.70001220703125, "invlev_up": 761.60003662109375, "invlev_dn": 745.20001220703125, "manhole_up": "manhole_700_generated", "manhole_dn": "manhole_701_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387066.165866439929232, 5861905.273926095105708 ], [ 1387016.666836149292067, 5861900.238133460283279 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E75", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.70001220703125, "elevtn_dn": 747.70001220703125, "invlev_up": 745.20001220703125, "invlev_dn": 745.20001220703125, "manhole_up": "manhole_701_generated", "manhole_dn": "manhole_702_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387016.666836149292067, 5861900.238133460283279 ], [ 1386975.698310127714649, 5861874.842493440955877 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E76", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.70001220703125, "elevtn_dn": 739.60003662109375, "invlev_up": 745.20001220703125, "invlev_dn": 737.10003662109375, "manhole_up": "manhole_702_generated", "manhole_dn": "manhole_703_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386975.698310127714649, 5861874.842493440955877 ], [ 1386937.286019780673087, 5861843.21080310922116 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E77", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.60003662109375, "elevtn_dn": 739.60003662109375, "invlev_up": 737.10003662109375, "invlev_dn": 737.10003662109375, "manhole_up": "manhole_703_generated", "manhole_dn": "manhole_704_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386937.286019780673087, 5861843.21080310922116 ], [ 1386898.873729433864355, 5861811.579112778417766 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E78", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.60003662109375, "elevtn_dn": 755.20001220703125, "invlev_up": 737.10003662109375, "invlev_dn": 752.70001220703125, "manhole_up": "manhole_704_generated", "manhole_dn": "manhole_705_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386898.873729433864355, 5861811.579112778417766 ], [ 1386860.461439087055624, 5861779.947422447614372 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E79", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.20001220703125, "elevtn_dn": 745.29998779296875, "invlev_up": 752.70001220703125, "invlev_dn": 742.79998779296875, "manhole_up": "manhole_705_generated", "manhole_dn": "manhole_706_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386860.461439087055624, 5861779.947422447614372 ], [ 1386822.049148740014061, 5861748.315732115879655 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E80", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 745.29998779296875, "elevtn_dn": 745.29998779296875, "invlev_up": 742.79998779296875, "invlev_dn": 742.79998779296875, "manhole_up": "manhole_706_generated", "manhole_dn": "manhole_707_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386822.049148740014061, 5861748.315732115879655 ], [ 1386774.418702265014872, 5861733.958941764198244 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E81", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 745.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 742.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_707_generated", "manhole_dn": "manhole_708_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386774.418702265014872, 5861733.958941764198244 ], [ 1386726.75721522886306, 5861719.660321676172316 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E82", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_708_generated", "manhole_dn": "manhole_709_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386726.75721522886306, 5861719.660321676172316 ], [ 1386681.211287560872734, 5861700.510515534318984 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E83", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 777.9000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_709_generated", "manhole_dn": "manhole_710_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386681.211287560872734, 5861700.510515534318984 ], [ 1386655.081909105414525, 5861659.807657876051962 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E84", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 758.79998779296875, "invlev_up": 775.4000244140625, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_710_generated", "manhole_dn": "manhole_711_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386655.081909105414525, 5861659.807657876051962 ], [ 1386647.41175345890224, 5861610.757949161343277 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E85", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_711_generated", "manhole_dn": "manhole_712_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386647.41175345890224, 5861610.757949161343277 ], [ 1386641.745189253240824, 5861561.363539570011199 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E86", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 732.4000244140625, "invlev_up": 756.29998779296875, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_712_generated", "manhole_dn": "manhole_713_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386641.745189253240824, 5861561.363539570011199 ], [ 1386642.37134926696308, 5861511.607376066967845 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E87", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_713_generated", "manhole_dn": "manhole_714_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386642.37134926696308, 5861511.607376066967845 ], [ 1386642.997509280918166, 5861461.851212563924491 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E88", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_714_generated", "manhole_dn": "manhole_715_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386642.997509280918166, 5861461.851212563924491 ], [ 1386643.623669294640422, 5861412.09504906181246 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E89", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 724.29998779296875, "invlev_up": 729.9000244140625, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_715_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386643.623669294640422, 5861412.09504906181246 ], [ 1386648.271799877518788, 5861347.644815167412162 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_35_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_35", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_35", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_716_generated", "manhole_dn": "manhole_717_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386060.978602184914052, 5859873.390328846871853 ], [ 1386078.54455375042744, 5859857.065600479952991 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_35_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_35", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_35", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_717_generated", "manhole_dn": "manhole_718_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386078.54455375042744, 5859857.065600479952991 ], [ 1386079.86695942771621, 5859885.500408614054322 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_36_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_36", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_36", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_719_generated", "manhole_dn": "manhole_716_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386030.926458492642269, 5859869.881591100245714 ], [ 1386060.978602184914052, 5859873.390328846871853 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_37_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_37", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_37", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_720_generated", "manhole_dn": "manhole_716_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386043.381105761509389, 5859908.11929196305573 ], [ 1386060.978602184914052, 5859873.390328846871853 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_38_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_38", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_718_generated", "manhole_dn": "manhole_721_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386079.86695942771621, 5859885.500408614054322 ], [ 1386081.40363402524963, 5859934.756705570034683 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_38_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_38", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_721_generated", "manhole_dn": "manhole_722_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386081.40363402524963, 5859934.756705570034683 ], [ 1386080.471781946951523, 5859983.948014200665057 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_38_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_38", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 756.5, "invlev_up": 763.79998779296875, "invlev_dn": 754.0, "manhole_up": "manhole_722_generated", "manhole_dn": "manhole_723_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386080.471781946951523, 5859983.948014200665057 ], [ 1386081.101269942475483, 5860033.01989212166518 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_39_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_39", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_718_generated", "manhole_dn": "manhole_724_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386079.86695942771621, 5859885.500408614054322 ], [ 1386051.415038994979113, 5859913.714703594334424 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_39_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_39", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_724_generated", "manhole_dn": "manhole_725_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386051.415038994979113, 5859913.714703594334424 ], [ 1386056.753747603856027, 5859949.43277302198112 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_39_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_39", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_725_generated", "manhole_dn": "manhole_726_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386056.753747603856027, 5859949.43277302198112 ], [ 1386070.153564189793542, 5859990.873222404159606 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_39_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_39", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 756.5, "invlev_up": 763.79998779296875, "invlev_dn": 754.0, "manhole_up": "manhole_726_generated", "manhole_dn": "manhole_723_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386070.153564189793542, 5859990.873222404159606 ], [ 1386081.101269942475483, 5860033.01989212166518 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.5, "elevtn_dn": 756.5, "invlev_up": 754.0, "invlev_dn": 754.0, "manhole_up": "manhole_723_generated", "manhole_dn": "manhole_727_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386081.101269942475483, 5860033.01989212166518 ], [ 1386095.159510504920036, 5860079.476792480796576 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.5, "elevtn_dn": 720.29998779296875, "invlev_up": 754.0, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_727_generated", "manhole_dn": "manhole_728_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386095.159510504920036, 5860079.476792480796576 ], [ 1386119.249574675457552, 5860122.285581497475505 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_728_generated", "manhole_dn": "manhole_729_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386119.249574675457552, 5860122.285581497475505 ], [ 1386143.813145637512207, 5860164.822058788500726 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 732.5, "invlev_up": 717.79998779296875, "invlev_dn": 730.0, "manhole_up": "manhole_729_generated", "manhole_dn": "manhole_730_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386143.813145637512207, 5860164.822058788500726 ], [ 1386168.698389830067754, 5860207.173543182201684 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.5, "elevtn_dn": 732.5, "invlev_up": 730.0, "invlev_dn": 730.0, "manhole_up": "manhole_730_generated", "manhole_dn": "manhole_731_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386168.698389830067754, 5860207.173543182201684 ], [ 1386190.960878706537187, 5860250.914158629253507 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.5, "elevtn_dn": 720.29998779296875, "invlev_up": 730.0, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_731_generated", "manhole_dn": "manhole_732_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386190.960878706537187, 5860250.914158629253507 ], [ 1386212.013376480899751, 5860295.295640649273992 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 729.10003662109375, "invlev_up": 717.79998779296875, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_732_generated", "manhole_dn": "manhole_733_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386212.013376480899751, 5860295.295640649273992 ], [ 1386233.065874255495146, 5860339.677122670225799 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 729.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_733_generated", "manhole_dn": "manhole_734_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386233.065874255495146, 5860339.677122670225799 ], [ 1386254.118372030090541, 5860384.058604690246284 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 729.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_734_generated", "manhole_dn": "manhole_735_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386254.118372030090541, 5860384.058604690246284 ], [ 1386270.265550139825791, 5860430.368606903590262 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 746.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 743.60003662109375, "manhole_up": "manhole_735_generated", "manhole_dn": "manhole_736_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386270.265550139825791, 5860430.368606903590262 ], [ 1386284.690116602927446, 5860477.310510716401041 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 746.10003662109375, "elevtn_dn": 746.10003662109375, "invlev_up": 743.60003662109375, "invlev_dn": 743.60003662109375, "manhole_up": "manhole_736_generated", "manhole_dn": "manhole_737_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386284.690116602927446, 5860477.310510716401041 ], [ 1386295.943752367515117, 5860525.125563691370189 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 746.10003662109375, "elevtn_dn": 720.29998779296875, "invlev_up": 743.60003662109375, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_737_generated", "manhole_dn": "manhole_738_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386295.943752367515117, 5860525.125563691370189 ], [ 1386307.197388132335618, 5860572.940616665408015 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_738_generated", "manhole_dn": "manhole_739_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386307.197388132335618, 5860572.940616665408015 ], [ 1386318.451023896923289, 5860620.755669640377164 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_739_generated", "manhole_dn": "manhole_740_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386318.451023896923289, 5860620.755669640377164 ], [ 1386329.704659661510959, 5860668.57072261441499 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 737.60003662109375, "invlev_up": 717.79998779296875, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_740_generated", "manhole_dn": "manhole_741_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386329.704659661510959, 5860668.57072261441499 ], [ 1386340.95829542633146, 5860716.385775589384139 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 737.60003662109375, "invlev_up": 735.10003662109375, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_741_generated", "manhole_dn": "manhole_742_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386340.95829542633146, 5860716.385775589384139 ], [ 1386352.211931190919131, 5860764.200828563421965 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 737.60003662109375, "invlev_up": 735.10003662109375, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_742_generated", "manhole_dn": "manhole_743_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386352.211931190919131, 5860764.200828563421965 ], [ 1386365.771370212780312, 5860811.365820310078561 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 744.5, "invlev_up": 735.10003662109375, "invlev_dn": 742.0, "manhole_up": "manhole_743_generated", "manhole_dn": "manhole_744_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386365.771370212780312, 5860811.365820310078561 ], [ 1386381.150273493025452, 5860858.017861452884972 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 744.5, "elevtn_dn": 724.29998779296875, "invlev_up": 742.0, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_744_generated", "manhole_dn": "manhole_745_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386381.150273493025452, 5860858.017861452884972 ], [ 1386398.399082327727228, 5860903.951519219204783 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_745_generated", "manhole_dn": "manhole_746_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386398.399082327727228, 5860903.951519219204783 ], [ 1386418.211523674428463, 5860948.90027645137161 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_746_generated", "manhole_dn": "manhole_747_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386418.211523674428463, 5860948.90027645137161 ], [ 1386441.67837643600069, 5860992.033180211670697 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_747_generated", "manhole_dn": "manhole_748_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386441.67837643600069, 5860992.033180211670697 ], [ 1386465.536530936835334, 5861034.971648660488427 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.9000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 722.4000244140625, "manhole_up": "manhole_748_generated", "manhole_dn": "manhole_749_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386465.536530936835334, 5861034.971648660488427 ], [ 1386489.394685437437147, 5861077.910117109306157 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.9000244140625, "elevtn_dn": 724.29998779296875, "invlev_up": 722.4000244140625, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_749_generated", "manhole_dn": "manhole_750_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386489.394685437437147, 5861077.910117109306157 ], [ 1386513.252839938271791, 5861120.848585557192564 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_750_generated", "manhole_dn": "manhole_751_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386513.252839938271791, 5861120.848585557192564 ], [ 1386537.110994438873604, 5861163.787054006010294 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_751_generated", "manhole_dn": "manhole_752_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386537.110994438873604, 5861163.787054006010294 ], [ 1386560.969148939708248, 5861206.725522454828024 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_752_generated", "manhole_dn": "manhole_753_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386560.969148939708248, 5861206.725522454828024 ], [ 1386584.827303440310061, 5861249.663990902714431 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_753_generated", "manhole_dn": "manhole_754_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386584.827303440310061, 5861249.663990902714431 ], [ 1386607.696082097478211, 5861293.105181481689215 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_754_generated", "manhole_dn": "manhole_755_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386607.696082097478211, 5861293.105181481689215 ], [ 1386626.999141034670174, 5861338.164890616200864 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 732.4000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_755_generated", "manhole_dn": "manhole_756_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386626.999141034670174, 5861338.164890616200864 ], [ 1386632.635544582502916, 5861386.242180755361915 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_756_generated", "manhole_dn": "manhole_757_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386632.635544582502916, 5861386.242180755361915 ], [ 1386628.332881111185998, 5861435.174896763637662 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_757_generated", "manhole_dn": "manhole_758_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386628.332881111185998, 5861435.174896763637662 ], [ 1386624.030217639869079, 5861484.107612771913409 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 758.79998779296875, "invlev_up": 729.9000244140625, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_758_generated", "manhole_dn": "manhole_759_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386624.030217639869079, 5861484.107612771913409 ], [ 1386619.72755416855216, 5861533.040328779257834 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_759_generated", "manhole_dn": "manhole_760_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386619.72755416855216, 5861533.040328779257834 ], [ 1386620.396809899713844, 5861581.843449912965298 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_760_generated", "manhole_dn": "manhole_761_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386620.396809899713844, 5861581.843449912965298 ], [ 1386627.242796876933426, 5861630.485572309233248 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 777.9000244140625, "invlev_up": 756.29998779296875, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_761_generated", "manhole_dn": "manhole_762_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386627.242796876933426, 5861630.485572309233248 ], [ 1386633.497009602142498, 5861679.177458625286818 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 777.9000244140625, "invlev_up": 775.4000244140625, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_762_generated", "manhole_dn": "manhole_763_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386633.497009602142498, 5861679.177458625286818 ], [ 1386633.587326586712152, 5861728.232037586160004 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 777.9000244140625, "invlev_up": 775.4000244140625, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_763_generated", "manhole_dn": "manhole_764_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386633.587326586712152, 5861728.232037586160004 ], [ 1386628.569951781770214, 5861777.096641942858696 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 787.0, "invlev_up": 775.4000244140625, "invlev_dn": 784.5, "manhole_up": "manhole_764_generated", "manhole_dn": "manhole_765_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386628.569951781770214, 5861777.096641942858696 ], [ 1386623.552576976828277, 5861825.961246299557388 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.0, "elevtn_dn": 787.0, "invlev_up": 784.5, "invlev_dn": 784.5, "manhole_up": "manhole_765_generated", "manhole_dn": "manhole_766_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386623.552576976828277, 5861825.961246299557388 ], [ 1386622.452884682221338, 5861875.377415779046714 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.0, "elevtn_dn": 768.0, "invlev_up": 784.5, "invlev_dn": 765.5, "manhole_up": "manhole_766_generated", "manhole_dn": "manhole_767_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386622.452884682221338, 5861875.377415779046714 ], [ 1386630.050831846194342, 5861924.208797036670148 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_767_generated", "manhole_dn": "manhole_768_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386630.050831846194342, 5861924.208797036670148 ], [ 1386645.112437101313844, 5861971.295391816645861 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_768_generated", "manhole_dn": "manhole_769_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386645.112437101313844, 5861971.295391816645861 ], [ 1386663.826805545249954, 5862017.116109635680914 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 729.0, "invlev_up": 765.5, "invlev_dn": 726.5, "manhole_up": "manhole_769_generated", "manhole_dn": "manhole_770_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386663.826805545249954, 5862017.116109635680914 ], [ 1386682.541173989186063, 5862062.93682745564729 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 729.0, "invlev_up": 726.5, "invlev_dn": 726.5, "manhole_up": "manhole_770_generated", "manhole_dn": "manhole_771_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386682.541173989186063, 5862062.93682745564729 ], [ 1386700.357504795538262, 5862109.113540357910097 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 729.0, "invlev_up": 726.5, "invlev_dn": 726.5, "manhole_up": "manhole_771_generated", "manhole_dn": "manhole_772_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386700.357504795538262, 5862109.113540357910097 ], [ 1386718.120609947945923, 5862155.311352676711977 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 724.29998779296875, "invlev_up": 726.5, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_772_generated", "manhole_dn": "manhole_773_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386718.120609947945923, 5862155.311352676711977 ], [ 1386735.883715100120753, 5862201.509164996445179 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_773_generated", "manhole_dn": "manhole_774_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386735.883715100120753, 5862201.509164996445179 ], [ 1386757.522535112220794, 5862245.993861058726907 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_774_generated", "manhole_dn": "manhole_775_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386757.522535112220794, 5862245.993861058726907 ], [ 1386779.73098383564502, 5862290.226773838512599 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_775_generated", "manhole_dn": "manhole_776_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386779.73098383564502, 5862290.226773838512599 ], [ 1386802.545179207576439, 5862334.095372994430363 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_776_generated", "manhole_dn": "manhole_777_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386802.545179207576439, 5862334.095372994430363 ], [ 1386831.207993831252679, 5862374.446442689746618 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 737.70001220703125, "invlev_up": 721.79998779296875, "invlev_dn": 735.20001220703125, "manhole_up": "manhole_777_generated", "manhole_dn": "manhole_778_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386831.207993831252679, 5862374.446442689746618 ], [ 1386859.988485741894692, 5862414.708453865721822 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.70001220703125, "elevtn_dn": 737.70001220703125, "invlev_up": 735.20001220703125, "invlev_dn": 735.20001220703125, "manhole_up": "manhole_778_generated", "manhole_dn": "manhole_779_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386859.988485741894692, 5862414.708453865721822 ], [ 1386891.035651177866384, 5862453.255039785988629 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.70001220703125, "elevtn_dn": 743.9000244140625, "invlev_up": 735.20001220703125, "invlev_dn": 741.4000244140625, "manhole_up": "manhole_779_generated", "manhole_dn": "manhole_780_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386891.035651177866384, 5862453.255039785988629 ], [ 1386922.082816614070907, 5862491.801625707186759 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 743.9000244140625, "elevtn_dn": 756.0, "invlev_up": 741.4000244140625, "invlev_dn": 753.5, "manhole_up": "manhole_780_generated", "manhole_dn": "manhole_781_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386922.082816614070907, 5862491.801625707186759 ], [ 1386953.12998205027543, 5862530.348211627453566 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.0, "elevtn_dn": 756.0, "invlev_up": 753.5, "invlev_dn": 753.5, "manhole_up": "manhole_781_generated", "manhole_dn": "manhole_782_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386953.12998205027543, 5862530.348211627453566 ], [ 1386984.177147486479953, 5862568.894797547720373 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.0, "elevtn_dn": 761.4000244140625, "invlev_up": 753.5, "invlev_dn": 758.9000244140625, "manhole_up": "manhole_782_generated", "manhole_dn": "manhole_783_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386984.177147486479953, 5862568.894797547720373 ], [ 1387010.83190148579888, 5862610.297833287157118 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.4000244140625, "elevtn_dn": 761.4000244140625, "invlev_up": 758.9000244140625, "invlev_dn": 758.9000244140625, "manhole_up": "manhole_783_generated", "manhole_dn": "manhole_784_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387010.83190148579888, 5862610.297833287157118 ], [ 1387033.474099110113457, 5862654.310293504968286 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.4000244140625, "elevtn_dn": 770.5, "invlev_up": 758.9000244140625, "invlev_dn": 768.0, "manhole_up": "manhole_784_generated", "manhole_dn": "manhole_785_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387033.474099110113457, 5862654.310293504968286 ], [ 1387056.116296734428033, 5862698.322753723710775 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.5, "elevtn_dn": 765.29998779296875, "invlev_up": 768.0, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_785_generated", "manhole_dn": "manhole_786_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387056.116296734428033, 5862698.322753723710775 ], [ 1387078.75849435874261, 5862742.335213942453265 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 765.29998779296875, "invlev_up": 762.79998779296875, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_786_generated", "manhole_dn": "manhole_787_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387078.75849435874261, 5862742.335213942453265 ], [ 1387101.400691983057186, 5862786.347674161195755 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 765.29998779296875, "invlev_up": 762.79998779296875, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_787_generated", "manhole_dn": "manhole_788_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387101.400691983057186, 5862786.347674161195755 ], [ 1387124.783531384309754, 5862829.966971693560481 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 764.20001220703125, "invlev_up": 762.79998779296875, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_788_generated", "manhole_dn": "manhole_789_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387124.783531384309754, 5862829.966971693560481 ], [ 1387148.551342260092497, 5862873.381910757161677 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 764.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_789_generated", "manhole_dn": "manhole_790_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387148.551342260092497, 5862873.381910757161677 ], [ 1387176.029596295906231, 5862914.516764627769589 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 764.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_790_generated", "manhole_dn": "manhole_791_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387176.029596295906231, 5862914.516764627769589 ], [ 1387204.050833505578339, 5862955.315435893833637 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 769.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 766.70001220703125, "manhole_up": "manhole_791_generated", "manhole_dn": "manhole_792_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387204.050833505578339, 5862955.315435893833637 ], [ 1387233.152246462181211, 5862995.351338926702738 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.20001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 766.70001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_792_generated", "manhole_dn": "manhole_793_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387233.152246462181211, 5862995.351338926702738 ], [ 1387262.253659419016913, 5863035.387241959571838 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 770.20001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_793_generated", "manhole_dn": "manhole_794_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387262.253659419016913, 5863035.387241959571838 ], [ 1387289.177211825968698, 5863076.714860137552023 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 770.20001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_794_generated", "manhole_dn": "manhole_795_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387289.177211825968698, 5863076.714860137552023 ], [ 1387304.666786204557866, 5863123.392671256326139 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 762.0, "invlev_up": 770.20001220703125, "invlev_dn": 759.5, "manhole_up": "manhole_795_generated", "manhole_dn": "manhole_796_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387304.666786204557866, 5863123.392671256326139 ], [ 1387314.520281337434426, 5863171.895173518918455 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 777.10003662109375, "invlev_up": 759.5, "invlev_dn": 774.60003662109375, "manhole_up": "manhole_796_generated", "manhole_dn": "manhole_797_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387314.520281337434426, 5863171.895173518918455 ], [ 1387324.142220750683919, 5863220.446013364940882 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.10003662109375, "elevtn_dn": 780.4000244140625, "invlev_up": 774.60003662109375, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_797_generated", "manhole_dn": "manhole_798_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387324.142220750683919, 5863220.446013364940882 ], [ 1387333.764160163700581, 5863268.996853210031986 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 780.4000244140625, "invlev_up": 777.9000244140625, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_798_generated", "manhole_dn": "manhole_799_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387333.764160163700581, 5863268.996853210031986 ], [ 1387343.386099576717243, 5863317.547693055123091 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 780.4000244140625, "invlev_up": 777.9000244140625, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_799_generated", "manhole_dn": "manhole_800_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387343.386099576717243, 5863317.547693055123091 ], [ 1387353.008038989733905, 5863366.098532900214195 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 762.0, "invlev_up": 777.9000244140625, "invlev_dn": 759.5, "manhole_up": "manhole_800_generated", "manhole_dn": "manhole_801_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387353.008038989733905, 5863366.098532900214195 ], [ 1387364.066297837067395, 5863414.311534740030766 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_801_generated", "manhole_dn": "manhole_802_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387364.066297837067395, 5863414.311534740030766 ], [ 1387381.839409928303212, 5863460.427046488039196 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_802_generated", "manhole_dn": "manhole_803_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387381.839409928303212, 5863460.427046488039196 ], [ 1387403.429578960640356, 5863504.96100580971688 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_803_generated", "manhole_dn": "manhole_804_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387403.429578960640356, 5863504.96100580971688 ], [ 1387425.140452897874638, 5863549.440256260335445 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_804_generated", "manhole_dn": "manhole_805_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387425.140452897874638, 5863549.440256260335445 ], [ 1387446.851326835108921, 5863593.91950671095401 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_805_generated", "manhole_dn": "manhole_806_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387446.851326835108921, 5863593.91950671095401 ], [ 1387467.528695637593046, 5863638.888379830867052 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 774.5, "invlev_up": 759.5, "invlev_dn": 772.0, "manhole_up": "manhole_806_generated", "manhole_dn": "manhole_807_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387467.528695637593046, 5863638.888379830867052 ], [ 1387488.196078018052503, 5863683.861984014511108 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.5, "elevtn_dn": 762.0, "invlev_up": 772.0, "invlev_dn": 759.5, "manhole_up": "manhole_807_generated", "manhole_dn": "manhole_808_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387488.196078018052503, 5863683.861984014511108 ], [ 1387508.863468252588063, 5863728.835584589280188 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_808_generated", "manhole_dn": "manhole_809_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387508.863468252588063, 5863728.835584589280188 ], [ 1387529.53130904212594, 5863773.808978110551834 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_809_generated", "manhole_dn": "manhole_810_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387529.53130904212594, 5863773.808978110551834 ], [ 1387553.168002701364458, 5863817.17347530182451 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_810_generated", "manhole_dn": "manhole_811_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387553.168002701364458, 5863817.17347530182451 ], [ 1387579.562712850514799, 5863859.043333718553185 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 777.0, "invlev_up": 759.5, "invlev_dn": 774.5, "manhole_up": "manhole_811_generated", "manhole_dn": "manhole_812_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387579.562712850514799, 5863859.043333718553185 ], [ 1387605.957422999665141, 5863900.913192136213183 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.0, "elevtn_dn": 762.0, "invlev_up": 774.5, "invlev_dn": 759.5, "manhole_up": "manhole_812_generated", "manhole_dn": "manhole_813_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387605.957422999665141, 5863900.913192136213183 ], [ 1387632.352133149048313, 5863942.783050553873181 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E48", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_813_generated", "manhole_dn": "manhole_814_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387632.352133149048313, 5863942.783050553873181 ], [ 1387658.746843298198655, 5863984.652908970601857 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E49", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_814_generated", "manhole_dn": "manhole_815_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387658.746843298198655, 5863984.652908970601857 ], [ 1387685.893106181640178, 5864026.029537551105022 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E50", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_815_generated", "manhole_dn": "manhole_816_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387685.893106181640178, 5864026.029537551105022 ], [ 1387711.231136992340907, 5864068.42725711222738 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E51", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_816_generated", "manhole_dn": "manhole_817_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387711.231136992340907, 5864068.42725711222738 ], [ 1387731.020947323646396, 5864113.414904261007905 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E52", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_817_generated", "manhole_dn": "manhole_818_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387731.020947323646396, 5864113.414904261007905 ], [ 1387737.361907477490604, 5864162.342261835932732 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E53", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_818_generated", "manhole_dn": "manhole_819_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387737.361907477490604, 5864162.342261835932732 ], [ 1387732.727565656881779, 5864211.475179814733565 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E54", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_819_generated", "manhole_dn": "manhole_820_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387732.727565656881779, 5864211.475179814733565 ], [ 1387717.67884943424724, 5864258.627082298509777 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E55", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_820_generated", "manhole_dn": "manhole_821_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387717.67884943424724, 5864258.627082298509777 ], [ 1387709.67210421175696, 5864307.23127611912787 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E56", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 768.0, "invlev_up": 759.5, "invlev_dn": 765.5, "manhole_up": "manhole_821_generated", "manhole_dn": "manhole_822_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387709.67210421175696, 5864307.23127611912787 ], [ 1387707.11288084089756, 5864356.66017600055784 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E57", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_822_generated", "manhole_dn": "manhole_823_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387707.11288084089756, 5864356.66017600055784 ], [ 1387709.591797993984073, 5864406.012949175201356 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E58", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_823_generated", "manhole_dn": "manhole_824_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387709.591797993984073, 5864406.012949175201356 ], [ 1387713.643261310644448, 5864455.341961052268744 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E59", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 777.20001220703125, "invlev_up": 765.5, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_824_generated", "manhole_dn": "manhole_825_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387713.643261310644448, 5864455.341961052268744 ], [ 1387715.877521668095142, 5864504.642317942343652 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E60", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 774.70001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_825_generated", "manhole_dn": "manhole_826_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387715.877521668095142, 5864504.642317942343652 ], [ 1387708.68023270717822, 5864553.426558391191065 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E61", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 774.70001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_826_generated", "manhole_dn": "manhole_827_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387708.68023270717822, 5864553.426558391191065 ], [ 1387690.790250770282, 5864599.575386263430119 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E62", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 810.60003662109375, "invlev_up": 774.70001220703125, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_827_generated", "manhole_dn": "manhole_828_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387690.790250770282, 5864599.575386263430119 ], [ 1387672.900268833618611, 5864645.724214136600494 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E63", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 810.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_828_generated", "manhole_dn": "manhole_829_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387672.900268833618611, 5864645.724214136600494 ], [ 1387659.931900478899479, 5864692.98388583958149 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E64", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 810.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_829_generated", "manhole_dn": "manhole_830_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387659.931900478899479, 5864692.98388583958149 ], [ 1387659.223570322152227, 5864742.029465307481587 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E65", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_830_generated", "manhole_dn": "manhole_831_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387659.223570322152227, 5864742.029465307481587 ], [ 1387675.926896508783102, 5864788.273513910360634 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E66", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 774.10003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 771.60003662109375, "manhole_up": "manhole_831_generated", "manhole_dn": "manhole_832_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387675.926896508783102, 5864788.273513910360634 ], [ 1387702.296291569946334, 5864830.159320239908993 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E67", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.10003662109375, "elevtn_dn": 774.10003662109375, "invlev_up": 771.60003662109375, "invlev_dn": 771.60003662109375, "manhole_up": "manhole_832_generated", "manhole_dn": "manhole_833_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387702.296291569946334, 5864830.159320239908993 ], [ 1387728.665686630876735, 5864872.045126569457352 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E68", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.10003662109375, "elevtn_dn": 782.5, "invlev_up": 771.60003662109375, "invlev_dn": 780.0, "manhole_up": "manhole_833_generated", "manhole_dn": "manhole_834_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387728.665686630876735, 5864872.045126569457352 ], [ 1387751.608185108983889, 5864915.528788692317903 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E69", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 782.5, "invlev_up": 780.0, "invlev_dn": 780.0, "manhole_up": "manhole_834_generated", "manhole_dn": "manhole_835_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387751.608185108983889, 5864915.528788692317903 ], [ 1387766.741664502769709, 5864962.653554677963257 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E70", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 782.5, "invlev_up": 780.0, "invlev_dn": 780.0, "manhole_up": "manhole_835_generated", "manhole_dn": "manhole_836_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387766.741664502769709, 5864962.653554677963257 ], [ 1387778.99191950308159, 5865010.246724016033113 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E71", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 820.20001220703125, "invlev_up": 780.0, "invlev_dn": 817.70001220703125, "manhole_up": "manhole_836_generated", "manhole_dn": "manhole_837_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387778.99191950308159, 5865010.246724016033113 ], [ 1387779.554608268430457, 5865059.738633952103555 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E72", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.20001220703125, "elevtn_dn": 820.20001220703125, "invlev_up": 817.70001220703125, "invlev_dn": 817.70001220703125, "manhole_up": "manhole_837_generated", "manhole_dn": "manhole_838_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387779.554608268430457, 5865059.738633952103555 ], [ 1387780.117297033779323, 5865109.230543887242675 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E73", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.20001220703125, "elevtn_dn": 834.60003662109375, "invlev_up": 817.70001220703125, "invlev_dn": 832.10003662109375, "manhole_up": "manhole_838_generated", "manhole_dn": "manhole_839_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387780.117297033779323, 5865109.230543887242675 ], [ 1387782.917817069217563, 5865158.566991245374084 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E74", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 834.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 832.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_839_generated", "manhole_dn": "manhole_840_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387782.917817069217563, 5865158.566991245374084 ], [ 1387789.203931836877018, 5865207.661293652839959 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E75", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_840_generated", "manhole_dn": "manhole_841_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387789.203931836877018, 5865207.661293652839959 ], [ 1387795.490046604769304, 5865256.755596060305834 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E76", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_841_generated", "manhole_dn": "manhole_842_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387795.490046604769304, 5865256.755596060305834 ], [ 1387804.549934879876673, 5865305.332479531876743 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E77", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 809.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_842_generated", "manhole_dn": "manhole_843_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387804.549934879876673, 5865305.332479531876743 ], [ 1387816.386747075244784, 5865353.391356389038265 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E78", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 809.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_843_generated", "manhole_dn": "manhole_844_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387816.386747075244784, 5865353.391356389038265 ], [ 1387828.223559270845726, 5865401.450233246199787 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E79", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 802.5, "invlev_up": 809.10003662109375, "invlev_dn": 800.0, "manhole_up": "manhole_844_generated", "manhole_dn": "manhole_845_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387828.223559270845726, 5865401.450233246199787 ], [ 1387842.96627543354407, 5865448.679594250395894 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E80", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 802.5, "invlev_up": 800.0, "invlev_dn": 800.0, "manhole_up": "manhole_845_generated", "manhole_dn": "manhole_846_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387842.96627543354407, 5865448.679594250395894 ], [ 1387858.283513206522912, 5865495.744953005574644 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E81", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 802.5, "invlev_up": 800.0, "invlev_dn": 800.0, "manhole_up": "manhole_846_generated", "manhole_dn": "manhole_847_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387858.283513206522912, 5865495.744953005574644 ], [ 1387872.788357679266483, 5865543.026506381109357 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E82", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 778.20001220703125, "invlev_up": 800.0, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_847_generated", "manhole_dn": "manhole_848_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387872.788357679266483, 5865543.026506381109357 ], [ 1387882.890574953285977, 5865591.479689701460302 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E83", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_848_generated", "manhole_dn": "manhole_849_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387882.890574953285977, 5865591.479689701460302 ], [ 1387892.992792227305472, 5865639.932873022742569 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E84", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_849_generated", "manhole_dn": "manhole_850_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387892.992792227305472, 5865639.932873022742569 ], [ 1387903.095009501324967, 5865688.386056343093514 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E85", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_850_generated", "manhole_dn": "manhole_851_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387903.095009501324967, 5865688.386056343093514 ], [ 1387913.197226775344461, 5865736.839239663444459 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 830.9000244140625, "invlev_up": 828.4000244140625, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_852_generated", "manhole_dn": "manhole_853_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387767.438602478476241, 5866395.894650792703032 ], [ 1387758.181959156645462, 5866444.388786932453513 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 830.9000244140625, "invlev_up": 828.4000244140625, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_853_generated", "manhole_dn": "manhole_854_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387758.181959156645462, 5866444.388786932453513 ], [ 1387748.925315835047513, 5866492.882923071272671 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 816.5, "invlev_up": 828.4000244140625, "invlev_dn": 814.0, "manhole_up": "manhole_854_generated", "manhole_dn": "manhole_855_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387748.925315835047513, 5866492.882923071272671 ], [ 1387739.668672513216734, 5866541.377059211023152 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.5, "elevtn_dn": 816.5, "invlev_up": 814.0, "invlev_dn": 814.0, "manhole_up": "manhole_855_generated", "manhole_dn": "manhole_856_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387739.668672513216734, 5866541.377059211023152 ], [ 1387730.412029191618785, 5866589.87119534984231 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.5, "elevtn_dn": 816.10003662109375, "invlev_up": 814.0, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_856_generated", "manhole_dn": "manhole_857_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387730.412029191618785, 5866589.87119534984231 ], [ 1387721.155385869788006, 5866638.365331489592791 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 816.10003662109375, "invlev_up": 813.60003662109375, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_857_generated", "manhole_dn": "manhole_858_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387721.155385869788006, 5866638.365331489592791 ], [ 1387711.868742506252602, 5866686.853722332976758 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 816.10003662109375, "invlev_up": 813.60003662109375, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_858_generated", "manhole_dn": "manhole_859_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387711.868742506252602, 5866686.853722332976758 ], [ 1387702.553355348296463, 5866735.336608462966979 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 802.4000244140625, "invlev_up": 813.60003662109375, "invlev_dn": 799.9000244140625, "manhole_up": "manhole_859_generated", "manhole_dn": "manhole_860_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387702.553355348296463, 5866735.336608462966979 ], [ 1387692.161796326050535, 5866783.420620376244187 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_43_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_43", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_43", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_861_generated", "manhole_dn": "manhole_862_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387809.534624515566975, 5866309.639251782558858 ], [ 1387788.486613497138023, 5866352.766951287165284 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_43_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_43", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_43", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 830.9000244140625, "invlev_up": 803.70001220703125, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_862_generated", "manhole_dn": "manhole_852_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387788.486613497138023, 5866352.766951287165284 ], [ 1387767.438602478476241, 5866395.894650792703032 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 840.10003662109375, "invlev_up": 828.4000244140625, "invlev_dn": 837.60003662109375, "manhole_up": "manhole_852_generated", "manhole_dn": "manhole_863_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387767.438602478476241, 5866395.894650792703032 ], [ 1387774.73306847945787, 5866351.644692087545991 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 840.10003662109375, "elevtn_dn": 806.20001220703125, "invlev_up": 837.60003662109375, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_863_generated", "manhole_dn": "manhole_864_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387774.73306847945787, 5866351.644692087545991 ], [ 1387787.219046234386042, 5866308.756401930935681 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_864_generated", "manhole_dn": "manhole_865_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387787.219046234386042, 5866308.756401930935681 ], [ 1387802.581935805035755, 5866266.622689731419086 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_865_generated", "manhole_dn": "manhole_866_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387802.581935805035755, 5866266.622689731419086 ], [ 1387818.989883717847988, 5866224.886323318816721 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_866_generated", "manhole_dn": "manhole_867_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387818.989883717847988, 5866224.886323318816721 ], [ 1387838.767447788733989, 5866184.784887914545834 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_867_generated", "manhole_dn": "manhole_868_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387838.767447788733989, 5866184.784887914545834 ], [ 1387862.375427621416748, 5866146.679679537191987 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 803.9000244140625, "invlev_up": 825.20001220703125, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_868_generated", "manhole_dn": "manhole_869_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387862.375427621416748, 5866146.679679537191987 ], [ 1387890.316308293025941, 5866111.904927220195532 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_869_generated", "manhole_dn": "manhole_870_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387890.316308293025941, 5866111.904927220195532 ], [ 1387932.086585889104754, 5866099.149365295656025 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_45_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_45", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_871_generated", "manhole_dn": "manhole_872_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387931.614702571649104, 5866170.542120457626879 ], [ 1387899.497387683717534, 5866203.806988564319909 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_45_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_45", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 806.20001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_872_generated", "manhole_dn": "manhole_873_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387899.497387683717534, 5866203.806988564319909 ], [ 1387869.509799961000681, 5866239.084409636445343 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_45_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_45", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_873_generated", "manhole_dn": "manhole_874_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387869.509799961000681, 5866239.084409636445343 ], [ 1387839.522212238283828, 5866274.361830709502101 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_45_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_45", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_874_generated", "manhole_dn": "manhole_861_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387839.522212238283828, 5866274.361830709502101 ], [ 1387809.534624515566975, 5866309.639251782558858 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_46_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_870_generated", "manhole_dn": "manhole_875_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387932.086585889104754, 5866099.149365295656025 ], [ 1387908.367353544337675, 5866141.903963415883482 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_46_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_875_generated", "manhole_dn": "manhole_876_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387908.367353544337675, 5866141.903963415883482 ], [ 1387876.955022902460769, 5866179.987773489207029 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_46_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 827.70001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_876_generated", "manhole_dn": "manhole_877_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387876.955022902460769, 5866179.987773489207029 ], [ 1387847.458594153402373, 5866219.470102892257273 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_46_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_877_generated", "manhole_dn": "manhole_878_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387847.458594153402373, 5866219.470102892257273 ], [ 1387823.639855962945148, 5866262.662997540086508 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_46_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_878_generated", "manhole_dn": "manhole_861_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387823.639855962945148, 5866262.662997540086508 ], [ 1387809.534624515566975, 5866309.639251782558858 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_47_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_879_generated", "manhole_dn": "manhole_880_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.443674022099003, 5865845.093254727311432 ], [ 1387943.318034203490242, 5865887.628139751963317 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_47_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_880_generated", "manhole_dn": "manhole_881_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387943.318034203490242, 5865887.628139751963317 ], [ 1387946.009428307646886, 5865930.175072746351361 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_47_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 816.70001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_881_generated", "manhole_dn": "manhole_882_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387946.009428307646886, 5865930.175072746351361 ], [ 1387948.700822412036359, 5865972.722005739808083 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_47_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_882_generated", "manhole_dn": "manhole_883_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387948.700822412036359, 5865972.722005739808083 ], [ 1387944.872250664513558, 5866015.105105520226061 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_47_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_883_generated", "manhole_dn": "manhole_884_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387944.872250664513558, 5866015.105105520226061 ], [ 1387940.047370131826028, 5866057.463170127011836 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_47_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 803.9000244140625, "invlev_up": 814.20001220703125, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_884_generated", "manhole_dn": "manhole_870_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.047370131826028, 5866057.463170127011836 ], [ 1387932.086585889104754, 5866099.149365295656025 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_48_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_48", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_48", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 786.29998779296875, "invlev_up": 801.4000244140625, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_870_generated", "manhole_dn": "manhole_885_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387932.086585889104754, 5866099.149365295656025 ], [ 1387975.279995472636074, 5866107.425722245126963 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E125", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.5, "elevtn_dn": 910.4000244140625, "invlev_up": 907.0, "invlev_dn": 907.9000244140625, "manhole_up": "manhole_886_generated", "manhole_dn": "manhole_887_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392926.966794768813998, 5866808.501405037939548 ], [ 1392879.417931769276038, 5866793.491589142940938 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E126", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 910.4000244140625, "elevtn_dn": 910.4000244140625, "invlev_up": 907.9000244140625, "invlev_dn": 907.9000244140625, "manhole_up": "manhole_887_generated", "manhole_dn": "manhole_888_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392879.417931769276038, 5866793.491589142940938 ], [ 1392831.869068769738078, 5866778.481773247942328 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E127", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 910.4000244140625, "elevtn_dn": 865.0, "invlev_up": 907.9000244140625, "invlev_dn": 862.5, "manhole_up": "manhole_888_generated", "manhole_dn": "manhole_889_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392831.869068769738078, 5866778.481773247942328 ], [ 1392784.320205770200118, 5866763.471957352943718 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E128", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 865.0, "elevtn_dn": 865.0, "invlev_up": 862.5, "invlev_dn": 862.5, "manhole_up": "manhole_889_generated", "manhole_dn": "manhole_890_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392784.320205770200118, 5866763.471957352943718 ], [ 1392736.771342770429328, 5866748.462141457945108 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E129", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 865.0, "elevtn_dn": 878.4000244140625, "invlev_up": 862.5, "invlev_dn": 875.9000244140625, "manhole_up": "manhole_890_generated", "manhole_dn": "manhole_891_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392736.771342770429328, 5866748.462141457945108 ], [ 1392689.222479770891368, 5866733.452325562946498 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E130", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 878.4000244140625, "elevtn_dn": 878.4000244140625, "invlev_up": 875.9000244140625, "invlev_dn": 875.9000244140625, "manhole_up": "manhole_891_generated", "manhole_dn": "manhole_892_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392689.222479770891368, 5866733.452325562946498 ], [ 1392641.673616771353409, 5866718.442509667947888 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E131", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 878.4000244140625, "elevtn_dn": 904.9000244140625, "invlev_up": 875.9000244140625, "invlev_dn": 902.4000244140625, "manhole_up": "manhole_892_generated", "manhole_dn": "manhole_893_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392641.673616771353409, 5866718.442509667947888 ], [ 1392594.124753771815449, 5866703.432693773880601 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E132", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 904.9000244140625, "elevtn_dn": 904.9000244140625, "invlev_up": 902.4000244140625, "invlev_dn": 902.4000244140625, "manhole_up": "manhole_893_generated", "manhole_dn": "manhole_894_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392594.124753771815449, 5866703.432693773880601 ], [ 1392546.575890772277489, 5866688.422877878881991 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E133", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 904.9000244140625, "elevtn_dn": 931.5, "invlev_up": 902.4000244140625, "invlev_dn": 929.0, "manhole_up": "manhole_894_generated", "manhole_dn": "manhole_895_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392546.575890772277489, 5866688.422877878881991 ], [ 1392499.02702777273953, 5866673.413061983883381 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E134", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 931.5, "elevtn_dn": 931.5, "invlev_up": 929.0, "invlev_dn": 929.0, "manhole_up": "manhole_895_generated", "manhole_dn": "manhole_896_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392499.02702777273953, 5866673.413061983883381 ], [ 1392451.47816477320157, 5866658.403246088884771 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E135", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 931.5, "elevtn_dn": 926.29998779296875, "invlev_up": 929.0, "invlev_dn": 923.79998779296875, "manhole_up": "manhole_896_generated", "manhole_dn": "manhole_897_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392451.47816477320157, 5866658.403246088884771 ], [ 1392403.92930177366361, 5866643.393430193886161 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E136", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 926.29998779296875, "elevtn_dn": 849.79998779296875, "invlev_up": 923.79998779296875, "invlev_dn": 847.29998779296875, "manhole_up": "manhole_897_generated", "manhole_dn": "manhole_898_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392403.92930177366361, 5866643.393430193886161 ], [ 1392356.380438774125651, 5866628.383614298887551 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E137", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 849.79998779296875, "elevtn_dn": 875.20001220703125, "invlev_up": 847.29998779296875, "invlev_dn": 872.70001220703125, "manhole_up": "manhole_898_generated", "manhole_dn": "manhole_899_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392356.380438774125651, 5866628.383614298887551 ], [ 1392308.831575774587691, 5866613.373798403888941 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E138", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 875.20001220703125, "elevtn_dn": 875.20001220703125, "invlev_up": 872.70001220703125, "invlev_dn": 872.70001220703125, "manhole_up": "manhole_899_generated", "manhole_dn": "manhole_900_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392308.831575774587691, 5866613.373798403888941 ], [ 1392261.282712775049731, 5866598.363982509821653 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E139", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 875.20001220703125, "elevtn_dn": 928.10003662109375, "invlev_up": 872.70001220703125, "invlev_dn": 925.60003662109375, "manhole_up": "manhole_900_generated", "manhole_dn": "manhole_901_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392261.282712775049731, 5866598.363982509821653 ], [ 1392213.733849775511771, 5866583.354166614823043 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E140", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 928.10003662109375, "elevtn_dn": 928.10003662109375, "invlev_up": 925.60003662109375, "invlev_dn": 925.60003662109375, "manhole_up": "manhole_901_generated", "manhole_dn": "manhole_902_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392213.733849775511771, 5866583.354166614823043 ], [ 1392166.184986775973812, 5866568.344350719824433 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E141", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 928.10003662109375, "elevtn_dn": 936.79998779296875, "invlev_up": 925.60003662109375, "invlev_dn": 934.29998779296875, "manhole_up": "manhole_902_generated", "manhole_dn": "manhole_903_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392166.184986775973812, 5866568.344350719824433 ], [ 1392119.234377897810191, 5866551.59017149079591 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E142", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 936.79998779296875, "elevtn_dn": 936.79998779296875, "invlev_up": 934.29998779296875, "invlev_dn": 934.29998779296875, "manhole_up": "manhole_903_generated", "manhole_dn": "manhole_904_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392119.234377897810191, 5866551.59017149079591 ], [ 1392072.481987217208371, 5866534.25803626794368 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E143", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 936.79998779296875, "elevtn_dn": 929.79998779296875, "invlev_up": 934.29998779296875, "invlev_dn": 927.29998779296875, "manhole_up": "manhole_904_generated", "manhole_dn": "manhole_905_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392072.481987217208371, 5866534.25803626794368 ], [ 1392025.729596536839381, 5866516.925901044160128 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E144", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 929.79998779296875, "elevtn_dn": 892.29998779296875, "invlev_up": 927.29998779296875, "invlev_dn": 889.79998779296875, "manhole_up": "manhole_905_generated", "manhole_dn": "manhole_906_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392025.729596536839381, 5866516.925901044160128 ], [ 1391978.977205856470391, 5866499.593765820376575 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E145", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 892.29998779296875, "elevtn_dn": 911.4000244140625, "invlev_up": 889.79998779296875, "invlev_dn": 908.9000244140625, "manhole_up": "manhole_906_generated", "manhole_dn": "manhole_907_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391978.977205856470391, 5866499.593765820376575 ], [ 1391932.224815175868571, 5866482.261630596593022 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E146", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.4000244140625, "elevtn_dn": 911.4000244140625, "invlev_up": 908.9000244140625, "invlev_dn": 908.9000244140625, "manhole_up": "manhole_907_generated", "manhole_dn": "manhole_908_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391932.224815175868571, 5866482.261630596593022 ], [ 1391885.472424495499581, 5866464.92949537280947 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E147", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.4000244140625, "elevtn_dn": 933.20001220703125, "invlev_up": 908.9000244140625, "invlev_dn": 930.70001220703125, "manhole_up": "manhole_908_generated", "manhole_dn": "manhole_909_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391885.472424495499581, 5866464.92949537280947 ], [ 1391838.720033814897761, 5866447.59736014995724 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E148", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.20001220703125, "elevtn_dn": 933.20001220703125, "invlev_up": 930.70001220703125, "invlev_dn": 930.70001220703125, "manhole_up": "manhole_909_generated", "manhole_dn": "manhole_910_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391838.720033814897761, 5866447.59736014995724 ], [ 1391791.967643134528771, 5866430.265224926173687 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E149", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.20001220703125, "elevtn_dn": 939.4000244140625, "invlev_up": 930.70001220703125, "invlev_dn": 936.9000244140625, "manhole_up": "manhole_910_generated", "manhole_dn": "manhole_911_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391791.967643134528771, 5866430.265224926173687 ], [ 1391745.215252453926951, 5866412.933089702390134 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E150", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 939.4000244140625, "elevtn_dn": 939.4000244140625, "invlev_up": 936.9000244140625, "invlev_dn": 936.9000244140625, "manhole_up": "manhole_911_generated", "manhole_dn": "manhole_912_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391745.215252453926951, 5866412.933089702390134 ], [ 1391698.462861773557961, 5866395.600954478606582 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E151", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 939.4000244140625, "elevtn_dn": 952.70001220703125, "invlev_up": 936.9000244140625, "invlev_dn": 950.20001220703125, "manhole_up": "manhole_912_generated", "manhole_dn": "manhole_913_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391698.462861773557961, 5866395.600954478606582 ], [ 1391651.710471092956141, 5866378.268819254823029 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E152", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.70001220703125, "elevtn_dn": 889.4000244140625, "invlev_up": 950.20001220703125, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_913_generated", "manhole_dn": "manhole_914_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391651.710471092956141, 5866378.268819254823029 ], [ 1391604.958080412587151, 5866360.936684031039476 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E153", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 848.70001220703125, "invlev_up": 886.9000244140625, "invlev_dn": 846.20001220703125, "manhole_up": "manhole_914_generated", "manhole_dn": "manhole_915_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391604.958080412587151, 5866360.936684031039476 ], [ 1391558.205689732218161, 5866343.604548808187246 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E154", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 848.70001220703125, "elevtn_dn": 848.70001220703125, "invlev_up": 846.20001220703125, "invlev_dn": 846.20001220703125, "manhole_up": "manhole_915_generated", "manhole_dn": "manhole_916_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391558.205689732218161, 5866343.604548808187246 ], [ 1391511.453299051616341, 5866326.272413584403694 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E155", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 848.70001220703125, "elevtn_dn": 846.0, "invlev_up": 846.20001220703125, "invlev_dn": 843.5, "manhole_up": "manhole_916_generated", "manhole_dn": "manhole_917_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391511.453299051616341, 5866326.272413584403694 ], [ 1391464.700908371247351, 5866308.940278360620141 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E156", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.0, "elevtn_dn": 846.0, "invlev_up": 843.5, "invlev_dn": 843.5, "manhole_up": "manhole_917_generated", "manhole_dn": "manhole_918_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391464.700908371247351, 5866308.940278360620141 ], [ 1391417.948517690645531, 5866291.608143136836588 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E157", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.0, "elevtn_dn": 849.9000244140625, "invlev_up": 843.5, "invlev_dn": 847.4000244140625, "manhole_up": "manhole_918_generated", "manhole_dn": "manhole_919_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391417.948517690645531, 5866291.608143136836588 ], [ 1391371.196127010276541, 5866274.276007913053036 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E158", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 849.9000244140625, "elevtn_dn": 849.9000244140625, "invlev_up": 847.4000244140625, "invlev_dn": 847.4000244140625, "manhole_up": "manhole_919_generated", "manhole_dn": "manhole_920_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391371.196127010276541, 5866274.276007913053036 ], [ 1391321.986832652939484, 5866269.550851707346737 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E159", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 849.9000244140625, "elevtn_dn": 895.70001220703125, "invlev_up": 847.4000244140625, "invlev_dn": 893.20001220703125, "manhole_up": "manhole_920_generated", "manhole_dn": "manhole_921_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391321.986832652939484, 5866269.550851707346737 ], [ 1391272.147464629728347, 5866268.058758955448866 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E160", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 895.70001220703125, "elevtn_dn": 895.70001220703125, "invlev_up": 893.20001220703125, "invlev_dn": 893.20001220703125, "manhole_up": "manhole_921_generated", "manhole_dn": "manhole_922_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391272.147464629728347, 5866268.058758955448866 ], [ 1391222.30809660628438, 5866266.566666204482317 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E161", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 895.70001220703125, "elevtn_dn": 932.0, "invlev_up": 893.20001220703125, "invlev_dn": 929.5, "manhole_up": "manhole_922_generated", "manhole_dn": "manhole_923_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391222.30809660628438, 5866266.566666204482317 ], [ 1391172.468728582840413, 5866265.074573452584445 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E162", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 932.0, "invlev_up": 929.5, "invlev_dn": 929.5, "manhole_up": "manhole_923_generated", "manhole_dn": "manhole_924_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391172.468728582840413, 5866265.074573452584445 ], [ 1391122.629360559629276, 5866263.582480700686574 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E163", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 915.20001220703125, "invlev_up": 929.5, "invlev_dn": 912.70001220703125, "manhole_up": "manhole_924_generated", "manhole_dn": "manhole_925_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391122.629360559629276, 5866263.582480700686574 ], [ 1391072.789992536185309, 5866262.090387949720025 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E164", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.20001220703125, "elevtn_dn": 880.70001220703125, "invlev_up": 912.70001220703125, "invlev_dn": 878.20001220703125, "manhole_up": "manhole_925_generated", "manhole_dn": "manhole_926_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391072.789992536185309, 5866262.090387949720025 ], [ 1391022.950624512741342, 5866260.598295197822154 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E165", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 880.70001220703125, "elevtn_dn": 880.70001220703125, "invlev_up": 878.20001220703125, "invlev_dn": 878.20001220703125, "manhole_up": "manhole_926_generated", "manhole_dn": "manhole_927_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391022.950624512741342, 5866260.598295197822154 ], [ 1390973.111256489530206, 5866259.106202445924282 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E166", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 880.70001220703125, "elevtn_dn": 889.4000244140625, "invlev_up": 878.20001220703125, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_927_generated", "manhole_dn": "manhole_928_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390973.111256489530206, 5866259.106202445924282 ], [ 1390923.271888466086239, 5866257.614109694957733 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E167", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 889.4000244140625, "invlev_up": 886.9000244140625, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_928_generated", "manhole_dn": "manhole_929_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390923.271888466086239, 5866257.614109694957733 ], [ 1390873.432520442642272, 5866256.122016943059862 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E168", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 935.79998779296875, "invlev_up": 886.9000244140625, "invlev_dn": 933.29998779296875, "manhole_up": "manhole_929_generated", "manhole_dn": "manhole_930_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390873.432520442642272, 5866256.122016943059862 ], [ 1390823.593152419198304, 5866254.62992419116199 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E169", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.79998779296875, "elevtn_dn": 935.79998779296875, "invlev_up": 933.29998779296875, "invlev_dn": 933.29998779296875, "manhole_up": "manhole_930_generated", "manhole_dn": "manhole_931_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390823.593152419198304, 5866254.62992419116199 ], [ 1390773.753784395987168, 5866253.137831440195441 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E170", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.79998779296875, "elevtn_dn": 957.79998779296875, "invlev_up": 933.29998779296875, "invlev_dn": 955.29998779296875, "manhole_up": "manhole_931_generated", "manhole_dn": "manhole_932_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390773.753784395987168, 5866253.137831440195441 ], [ 1390723.914416372543201, 5866251.64573868829757 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E171", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.79998779296875, "elevtn_dn": 957.79998779296875, "invlev_up": 955.29998779296875, "invlev_dn": 955.29998779296875, "manhole_up": "manhole_932_generated", "manhole_dn": "manhole_933_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390723.914416372543201, 5866251.64573868829757 ], [ 1390674.075048349099234, 5866250.153645936399698 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E172", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.79998779296875, "elevtn_dn": 957.0, "invlev_up": 955.29998779296875, "invlev_dn": 954.5, "manhole_up": "manhole_933_generated", "manhole_dn": "manhole_934_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390674.075048349099234, 5866250.153645936399698 ], [ 1390624.235680325888097, 5866248.661553185433149 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E173", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.0, "elevtn_dn": 957.0, "invlev_up": 954.5, "invlev_dn": 954.5, "manhole_up": "manhole_934_generated", "manhole_dn": "manhole_935_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390624.235680325888097, 5866248.661553185433149 ], [ 1390574.39631230244413, 5866247.169460433535278 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E174", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.0, "elevtn_dn": 964.5, "invlev_up": 954.5, "invlev_dn": 962.0, "manhole_up": "manhole_935_generated", "manhole_dn": "manhole_936_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390574.39631230244413, 5866247.169460433535278 ], [ 1390524.556944279000163, 5866245.677367681637406 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E175", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 964.5, "invlev_up": 962.0, "invlev_dn": 962.0, "manhole_up": "manhole_936_generated", "manhole_dn": "manhole_937_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390524.556944279000163, 5866245.677367681637406 ], [ 1390474.717576255789027, 5866244.185274930670857 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E176", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 948.5, "invlev_up": 962.0, "invlev_dn": 946.0, "manhole_up": "manhole_937_generated", "manhole_dn": "manhole_938_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390474.717576255789027, 5866244.185274930670857 ], [ 1390424.87820823234506, 5866242.693182178772986 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E177", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 948.5, "elevtn_dn": 970.10003662109375, "invlev_up": 946.0, "invlev_dn": 967.60003662109375, "manhole_up": "manhole_938_generated", "manhole_dn": "manhole_939_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390424.87820823234506, 5866242.693182178772986 ], [ 1390375.038840208901092, 5866241.201089426875114 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E178", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 970.10003662109375, "elevtn_dn": 970.10003662109375, "invlev_up": 967.60003662109375, "invlev_dn": 967.60003662109375, "manhole_up": "manhole_939_generated", "manhole_dn": "manhole_940_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390375.038840208901092, 5866241.201089426875114 ], [ 1390325.199472185689956, 5866239.708996675908566 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E179", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 970.10003662109375, "elevtn_dn": 975.4000244140625, "invlev_up": 967.60003662109375, "invlev_dn": 972.9000244140625, "manhole_up": "manhole_940_generated", "manhole_dn": "manhole_941_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390325.199472185689956, 5866239.708996675908566 ], [ 1390275.360104162245989, 5866238.216903924010694 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E180", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 975.4000244140625, "elevtn_dn": 975.4000244140625, "invlev_up": 972.9000244140625, "invlev_dn": 972.9000244140625, "manhole_up": "manhole_941_generated", "manhole_dn": "manhole_942_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390275.360104162245989, 5866238.216903924010694 ], [ 1390225.520736138802022, 5866236.724811173044145 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E181", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 975.4000244140625, "elevtn_dn": 1034.5, "invlev_up": 972.9000244140625, "invlev_dn": 1032.0, "manhole_up": "manhole_942_generated", "manhole_dn": "manhole_943_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390225.520736138802022, 5866236.724811173044145 ], [ 1390175.681368115358055, 5866235.232718421146274 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E182", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1034.5, "elevtn_dn": 1034.5, "invlev_up": 1032.0, "invlev_dn": 1032.0, "manhole_up": "manhole_943_generated", "manhole_dn": "manhole_944_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390175.681368115358055, 5866235.232718421146274 ], [ 1390125.842000092146918, 5866233.740625669248402 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E183", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1034.5, "elevtn_dn": 1053.9000244140625, "invlev_up": 1032.0, "invlev_dn": 1051.4000244140625, "manhole_up": "manhole_944_generated", "manhole_dn": "manhole_945_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390125.842000092146918, 5866233.740625669248402 ], [ 1390076.002632068702951, 5866232.248532918281853 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E184", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.9000244140625, "elevtn_dn": 956.9000244140625, "invlev_up": 1051.4000244140625, "invlev_dn": 954.4000244140625, "manhole_up": "manhole_945_generated", "manhole_dn": "manhole_946_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390076.002632068702951, 5866232.248532918281853 ], [ 1390026.163264045258984, 5866230.756440166383982 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E185", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 956.9000244140625, "elevtn_dn": 988.79998779296875, "invlev_up": 954.4000244140625, "invlev_dn": 986.29998779296875, "manhole_up": "manhole_946_generated", "manhole_dn": "manhole_947_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390026.163264045258984, 5866230.756440166383982 ], [ 1389976.323896022047848, 5866229.26434741448611 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E186", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 988.79998779296875, "elevtn_dn": 988.79998779296875, "invlev_up": 986.29998779296875, "invlev_dn": 986.29998779296875, "manhole_up": "manhole_947_generated", "manhole_dn": "manhole_948_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389976.323896022047848, 5866229.26434741448611 ], [ 1389926.48452799860388, 5866227.772254663519561 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E187", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 988.79998779296875, "elevtn_dn": 1051.0999755859375, "invlev_up": 986.29998779296875, "invlev_dn": 1048.5999755859375, "manhole_up": "manhole_948_generated", "manhole_dn": "manhole_949_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389926.48452799860388, 5866227.772254663519561 ], [ 1389876.645159975159913, 5866226.28016191162169 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E188", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1051.0999755859375, "elevtn_dn": 1051.0999755859375, "invlev_up": 1048.5999755859375, "invlev_dn": 1048.5999755859375, "manhole_up": "manhole_949_generated", "manhole_dn": "manhole_950_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389876.645159975159913, 5866226.28016191162169 ], [ 1389826.805791951948777, 5866224.788069159723818 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E189", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1051.0999755859375, "elevtn_dn": 1066.9000244140625, "invlev_up": 1048.5999755859375, "invlev_dn": 1064.4000244140625, "manhole_up": "manhole_950_generated", "manhole_dn": "manhole_951_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389826.805791951948777, 5866224.788069159723818 ], [ 1389776.96642392850481, 5866223.295976408757269 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E190", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1066.9000244140625, "elevtn_dn": 1031.2000732421875, "invlev_up": 1064.4000244140625, "invlev_dn": 1028.7000732421875, "manhole_up": "manhole_951_generated", "manhole_dn": "manhole_952_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389776.96642392850481, 5866223.295976408757269 ], [ 1389727.141182830790058, 5866221.468200048431754 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E191", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1031.2000732421875, "elevtn_dn": 1031.2000732421875, "invlev_up": 1028.7000732421875, "invlev_dn": 1028.7000732421875, "manhole_up": "manhole_952_generated", "manhole_dn": "manhole_953_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389727.141182830790058, 5866221.468200048431754 ], [ 1389677.352675863076001, 5866218.767548334784806 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E192", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1031.2000732421875, "elevtn_dn": 986.60003662109375, "invlev_up": 1028.7000732421875, "invlev_dn": 984.10003662109375, "manhole_up": "manhole_953_generated", "manhole_dn": "manhole_954_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389677.352675863076001, 5866218.767548334784806 ], [ 1389627.564168895594776, 5866216.066896621137857 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E193", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 986.60003662109375, "elevtn_dn": 986.60003662109375, "invlev_up": 984.10003662109375, "invlev_dn": 984.10003662109375, "manhole_up": "manhole_954_generated", "manhole_dn": "manhole_955_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389627.564168895594776, 5866216.066896621137857 ], [ 1389577.775661927880719, 5866213.366244907490909 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E194", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 986.60003662109375, "elevtn_dn": 964.70001220703125, "invlev_up": 984.10003662109375, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_955_generated", "manhole_dn": "manhole_956_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389577.775661927880719, 5866213.366244907490909 ], [ 1389527.987154960166663, 5866210.665593194775283 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E195", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 964.70001220703125, "invlev_up": 962.20001220703125, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_956_generated", "manhole_dn": "manhole_957_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389527.987154960166663, 5866210.665593194775283 ], [ 1389478.198647992452607, 5866207.964941481128335 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E196", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 996.29998779296875, "invlev_up": 962.20001220703125, "invlev_dn": 993.79998779296875, "manhole_up": "manhole_957_generated", "manhole_dn": "manhole_958_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389478.198647992452607, 5866207.964941481128335 ], [ 1389428.41014102473855, 5866205.264289767481387 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E197", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 996.29998779296875, "elevtn_dn": 996.29998779296875, "invlev_up": 993.79998779296875, "invlev_dn": 993.79998779296875, "manhole_up": "manhole_958_generated", "manhole_dn": "manhole_959_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389428.41014102473855, 5866205.264289767481387 ], [ 1389378.621634057024494, 5866202.563638053834438 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E198", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 996.29998779296875, "elevtn_dn": 1030.4000244140625, "invlev_up": 993.79998779296875, "invlev_dn": 1027.9000244140625, "manhole_up": "manhole_959_generated", "manhole_dn": "manhole_960_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389378.621634057024494, 5866202.563638053834438 ], [ 1389328.833127089310437, 5866199.86298634018749 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E199", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1030.4000244140625, "elevtn_dn": 1030.4000244140625, "invlev_up": 1027.9000244140625, "invlev_dn": 1027.9000244140625, "manhole_up": "manhole_960_generated", "manhole_dn": "manhole_961_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389328.833127089310437, 5866199.86298634018749 ], [ 1389279.044620121829212, 5866197.162334626540542 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E200", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1030.4000244140625, "elevtn_dn": 1053.800048828125, "invlev_up": 1027.9000244140625, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_961_generated", "manhole_dn": "manhole_962_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389279.044620121829212, 5866197.162334626540542 ], [ 1389229.256113154115155, 5866194.461682912893593 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E201", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1053.800048828125, "invlev_up": 1051.300048828125, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_962_generated", "manhole_dn": "manhole_963_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389229.256113154115155, 5866194.461682912893593 ], [ 1389179.467606186401099, 5866191.761031199246645 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E202", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1067.5999755859375, "invlev_up": 1051.300048828125, "invlev_dn": 1065.0999755859375, "manhole_up": "manhole_963_generated", "manhole_dn": "manhole_964_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389179.467606186401099, 5866191.761031199246645 ], [ 1389129.679099218687043, 5866189.060379485599697 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E203", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1067.5999755859375, "elevtn_dn": 1070.7000732421875, "invlev_up": 1065.0999755859375, "invlev_dn": 1068.2000732421875, "manhole_up": "manhole_964_generated", "manhole_dn": "manhole_965_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389129.679099218687043, 5866189.060379485599697 ], [ 1389079.890592250972986, 5866186.359727771952748 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E204", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1070.7000732421875, "elevtn_dn": 1070.7000732421875, "invlev_up": 1068.2000732421875, "invlev_dn": 1068.2000732421875, "manhole_up": "manhole_965_generated", "manhole_dn": "manhole_966_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389079.890592250972986, 5866186.359727771952748 ], [ 1389030.10208528325893, 5866183.6590760583058 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E205", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1070.7000732421875, "elevtn_dn": 1075.0, "invlev_up": 1068.2000732421875, "invlev_dn": 1072.5, "manhole_up": "manhole_966_generated", "manhole_dn": "manhole_967_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389030.10208528325893, 5866183.6590760583058 ], [ 1388980.313578315777704, 5866180.958424345590174 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E206", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1075.0, "elevtn_dn": 1075.0, "invlev_up": 1072.5, "invlev_dn": 1072.5, "manhole_up": "manhole_967_generated", "manhole_dn": "manhole_968_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388980.313578315777704, 5866180.958424345590174 ], [ 1388930.525071348063648, 5866178.257772631943226 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E207", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1075.0, "elevtn_dn": 1074.0999755859375, "invlev_up": 1072.5, "invlev_dn": 1071.5999755859375, "manhole_up": "manhole_968_generated", "manhole_dn": "manhole_969_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388930.525071348063648, 5866178.257772631943226 ], [ 1388880.736564380349591, 5866175.557120918296278 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E208", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1074.0999755859375, "elevtn_dn": 1074.0999755859375, "invlev_up": 1071.5999755859375, "invlev_dn": 1071.5999755859375, "manhole_up": "manhole_969_generated", "manhole_dn": "manhole_970_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388880.736564380349591, 5866175.557120918296278 ], [ 1388830.948057412635535, 5866172.856469204649329 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E209", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1074.0999755859375, "elevtn_dn": 1053.800048828125, "invlev_up": 1071.5999755859375, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_970_generated", "manhole_dn": "manhole_971_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388830.948057412635535, 5866172.856469204649329 ], [ 1388781.159550444921479, 5866170.155817491002381 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E210", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1053.800048828125, "invlev_up": 1051.300048828125, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_971_generated", "manhole_dn": "manhole_972_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388781.159550444921479, 5866170.155817491002381 ], [ 1388731.371043477207422, 5866167.455165777355433 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E211", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1017.0, "invlev_up": 1051.300048828125, "invlev_dn": 1014.5, "manhole_up": "manhole_972_generated", "manhole_dn": "manhole_973_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388731.371043477207422, 5866167.455165777355433 ], [ 1388681.582536509493366, 5866164.754514063708484 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E212", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1017.0, "elevtn_dn": 1017.0, "invlev_up": 1014.5, "invlev_dn": 1014.5, "manhole_up": "manhole_973_generated", "manhole_dn": "manhole_974_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388681.582536509493366, 5866164.754514063708484 ], [ 1388631.79402954201214, 5866162.053862350061536 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E213", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1017.0, "elevtn_dn": 973.20001220703125, "invlev_up": 1014.5, "invlev_dn": 970.70001220703125, "manhole_up": "manhole_974_generated", "manhole_dn": "manhole_975_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388631.79402954201214, 5866162.053862350061536 ], [ 1388582.005522574298084, 5866159.353210636414587 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E214", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 973.20001220703125, "elevtn_dn": 973.20001220703125, "invlev_up": 970.70001220703125, "invlev_dn": 970.70001220703125, "manhole_up": "manhole_975_generated", "manhole_dn": "manhole_976_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388582.005522574298084, 5866159.353210636414587 ], [ 1388532.217015606584027, 5866156.652558922767639 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E215", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 973.20001220703125, "elevtn_dn": 935.20001220703125, "invlev_up": 970.70001220703125, "invlev_dn": 932.70001220703125, "manhole_up": "manhole_976_generated", "manhole_dn": "manhole_977_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388532.217015606584027, 5866156.652558922767639 ], [ 1388482.428508638869971, 5866153.951907209120691 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E216", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.20001220703125, "elevtn_dn": 935.20001220703125, "invlev_up": 932.70001220703125, "invlev_dn": 932.70001220703125, "manhole_up": "manhole_977_generated", "manhole_dn": "manhole_978_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388482.428508638869971, 5866153.951907209120691 ], [ 1388432.640001671155915, 5866151.251255496405065 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E217", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.20001220703125, "elevtn_dn": 895.79998779296875, "invlev_up": 932.70001220703125, "invlev_dn": 893.29998779296875, "manhole_up": "manhole_978_generated", "manhole_dn": "manhole_979_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388432.640001671155915, 5866151.251255496405065 ], [ 1388382.851494703441858, 5866148.550603782758117 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E218", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 895.79998779296875, "elevtn_dn": 852.60003662109375, "invlev_up": 893.29998779296875, "invlev_dn": 850.10003662109375, "manhole_up": "manhole_979_generated", "manhole_dn": "manhole_980_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388382.851494703441858, 5866148.550603782758117 ], [ 1388333.062987735960633, 5866145.849952069111168 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E219", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 852.60003662109375, "elevtn_dn": 852.60003662109375, "invlev_up": 850.10003662109375, "invlev_dn": 850.10003662109375, "manhole_up": "manhole_980_generated", "manhole_dn": "manhole_981_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388333.062987735960633, 5866145.849952069111168 ], [ 1388283.274480768246576, 5866143.14930035546422 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E220", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 852.60003662109375, "elevtn_dn": 818.4000244140625, "invlev_up": 850.10003662109375, "invlev_dn": 815.9000244140625, "manhole_up": "manhole_981_generated", "manhole_dn": "manhole_982_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388283.274480768246576, 5866143.14930035546422 ], [ 1388233.48597380053252, 5866140.448648641817272 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E221", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.4000244140625, "elevtn_dn": 818.4000244140625, "invlev_up": 815.9000244140625, "invlev_dn": 815.9000244140625, "manhole_up": "manhole_982_generated", "manhole_dn": "manhole_983_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388233.48597380053252, 5866140.448648641817272 ], [ 1388183.697466832818463, 5866137.747996928170323 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 792.20001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_851_generated", "manhole_dn": "manhole_984_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387913.197226775344461, 5865736.839239663444459 ], [ 1387925.20445894007571, 5865784.545682998374104 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 804.4000244140625, "invlev_up": 792.20001220703125, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_984_generated", "manhole_dn": "manhole_985_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387925.20445894007571, 5865784.545682998374104 ], [ 1387937.21169110503979, 5865832.252126332372427 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_985_generated", "manhole_dn": "manhole_986_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387937.21169110503979, 5865832.252126332372427 ], [ 1387954.8270876808092, 5865878.043407939374447 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_986_generated", "manhole_dn": "manhole_987_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387954.8270876808092, 5865878.043407939374447 ], [ 1387967.620662312954664, 5865925.436966767534614 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 778.20001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_987_generated", "manhole_dn": "manhole_988_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387967.620662312954664, 5865925.436966767534614 ], [ 1387969.561903131194413, 5865974.386314341798425 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_988_generated", "manhole_dn": "manhole_989_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.561903131194413, 5865974.386314341798425 ], [ 1387968.98255812516436, 5866023.571071763522923 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_989_generated", "manhole_dn": "manhole_990_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387968.98255812516436, 5866023.571071763522923 ], [ 1387969.225197304505855, 5866072.657253311946988 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 786.29998779296875, "invlev_up": 775.70001220703125, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_990_generated", "manhole_dn": "manhole_991_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.225197304505855, 5866072.657253311946988 ], [ 1387988.247399942483753, 5866112.298415473662317 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 786.29998779296875, "invlev_up": 783.79998779296875, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_991_generated", "manhole_dn": "manhole_992_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387988.247399942483753, 5866112.298415473662317 ], [ 1388034.037428337847814, 5866130.255607943050563 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 786.29998779296875, "invlev_up": 783.79998779296875, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_992_generated", "manhole_dn": "manhole_993_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388034.037428337847814, 5866130.255607943050563 ], [ 1387988.210684564430267, 5866144.678138472139835 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 803.9000244140625, "invlev_up": 783.79998779296875, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_993_generated", "manhole_dn": "manhole_994_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387988.210684564430267, 5866144.678138472139835 ], [ 1387944.406121137319133, 5866164.065103021450341 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_994_generated", "manhole_dn": "manhole_995_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387944.406121137319133, 5866164.065103021450341 ], [ 1387898.376188111724332, 5866173.560075835324824 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 827.70001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_995_generated", "manhole_dn": "manhole_996_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387898.376188111724332, 5866173.560075835324824 ], [ 1387861.922560503939167, 5866145.113870099186897 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_996_generated", "manhole_dn": "manhole_997_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387861.922560503939167, 5866145.113870099186897 ], [ 1387862.597008766839281, 5866099.287653629668057 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_997_generated", "manhole_dn": "manhole_998_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387862.597008766839281, 5866099.287653629668057 ], [ 1387894.296242429409176, 5866064.31225199252367 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_998_generated", "manhole_dn": "manhole_999_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387894.296242429409176, 5866064.31225199252367 ], [ 1387918.333023339277133, 5866023.860149594023824 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_999_generated", "manhole_dn": "manhole_1000_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387918.333023339277133, 5866023.860149594023824 ], [ 1387925.576027213362977, 5865976.462517648003995 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 804.4000244140625, "invlev_up": 814.20001220703125, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1000_generated", "manhole_dn": "manhole_1001_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387925.576027213362977, 5865976.462517648003995 ], [ 1387926.166851800866425, 5865928.505292822606862 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1001_generated", "manhole_dn": "manhole_1002_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387926.166851800866425, 5865928.505292822606862 ], [ 1387922.175474973395467, 5865880.628693707287312 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1002_generated", "manhole_dn": "manhole_1003_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387922.175474973395467, 5865880.628693707287312 ], [ 1387918.184098146157339, 5865832.752094592899084 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 794.70001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_1003_generated", "manhole_dn": "manhole_1004_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387918.184098146157339, 5865832.752094592899084 ], [ 1387914.316889721900225, 5865784.868878290057182 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 792.20001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_1004_generated", "manhole_dn": "manhole_851_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387914.316889721900225, 5865784.868878290057182 ], [ 1387913.197226775344461, 5865736.839239663444459 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_52_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_52", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.4000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 815.9000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_983_generated", "manhole_dn": "manhole_1005_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388183.697466832818463, 5866137.747996928170323 ], [ 1388133.810787334572524, 5866135.250533932819963 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_52_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_52", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_1005_generated", "manhole_dn": "manhole_1006_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388133.810787334572524, 5866135.250533932819963 ], [ 1388083.924107836093754, 5866132.753070938400924 ] ] } }, +{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_52_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_52", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 786.29998779296875, "invlev_up": 801.4000244140625, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_1006_generated", "manhole_dn": "manhole_992_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388083.924107836093754, 5866132.753070938400924 ], [ 1388034.037428337847814, 5866130.255607943050563 ] ] } } ] } diff --git a/examples/dflowfm_piave/geoms/rivers.geojson b/examples/dflowfm_piave/geoms/rivers.geojson index 5aab1261..bca2a36f 100644 --- a/examples/dflowfm_piave/geoms/rivers.geojson +++ b/examples/dflowfm_piave/geoms/rivers.geojson @@ -2,11 +2,11 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::3857" } }, "features": [ -{ "type": "Feature", "properties": { "height": 22.5, "width": 60.500781333333329, "bedlev": 865.60003662109375, "branchid": "river_1", "branchtype": "river", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_1", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1394694.070276216836646, 5867648.108302162960172 ], [ 1394694.070276216836646, 5867513.239712204784155 ], [ 1394601.304033889202401, 5867378.373192292638123 ], [ 1394508.537791561568156, 5867243.508742331527174 ], [ 1394415.771549233933911, 5867243.508742331527174 ], [ 1394323.005306906066835, 5867108.646362232975662 ], [ 1394230.23906457843259, 5867108.646362232975662 ], [ 1394137.472822251031175, 5867108.646362232975662 ], [ 1394044.70657992339693, 5866973.78605190385133 ], [ 1393951.940337595762685, 5866973.78605190385133 ], [ 1393859.17409526812844, 5866973.78605190385133 ], [ 1393766.407852940494195, 5866838.927811251021922 ], [ 1393673.641610612627119, 5866838.927811251021922 ], [ 1393580.875368284992874, 5866838.927811251021922 ], [ 1393488.109125957358629, 5866838.927811251021922 ], [ 1393395.342883629724383, 5866838.927811251021922 ], [ 1393302.576641302322969, 5866838.927811251021922 ], [ 1393209.810398974688724, 5866838.927811251021922 ], [ 1393117.044156646821648, 5866704.071640183217824 ], [ 1393024.277914319187403, 5866704.071640183217824 ], [ 1392931.511671991553158, 5866704.071640183217824 ], [ 1392838.745429663918912, 5866704.071640183217824 ], [ 1392745.979187336284667, 5866569.217538607306778 ], [ 1392653.212945008650422, 5866569.217538607306778 ], [ 1392560.446702681016177, 5866569.217538607306778 ], [ 1392467.680460353381932, 5866569.217538607306778 ], [ 1392374.914218025747687, 5866569.217538607306778 ], [ 1392282.147975698113441, 5866434.365506432950497 ], [ 1392189.381733370479196, 5866299.515543567948043 ], [ 1392096.615491042844951, 5866299.515543567948043 ], [ 1392003.849248715210706, 5866299.515543567948043 ], [ 1391911.083006387576461, 5866299.515543567948043 ], [ 1391818.316764059709385, 5866164.667649918235838 ], [ 1391725.55052173207514, 5866164.667649918235838 ], [ 1391632.784279404673725, 5866164.667649918235838 ], [ 1391540.01803707703948, 5866164.667649918235838 ], [ 1391447.251794749405235, 5866164.667649918235838 ], [ 1391354.48555242177099, 5866164.667649918235838 ], [ 1391261.719310093903914, 5866164.667649918235838 ], [ 1391168.953067766269669, 5866164.667649918235838 ], [ 1391076.186825438635424, 5866164.667649918235838 ], [ 1390983.420583111001179, 5866164.667649918235838 ], [ 1390890.654340783366933, 5866164.667649918235838 ], [ 1390797.888098455965519, 5866029.821825394406915 ], [ 1390705.121856128098443, 5866029.821825394406915 ], [ 1390612.355613800464198, 5866029.821825394406915 ], [ 1390519.589371472829953, 5866029.821825394406915 ], [ 1390426.823129145195708, 5866029.821825394406915 ], [ 1390334.056886817561463, 5866029.821825394406915 ], [ 1390241.290644489927217, 5866029.821825394406915 ], [ 1390148.524402162292972, 5865894.978069902397692 ], [ 1390055.758159834658727, 5865894.978069902397692 ], [ 1389962.991917507024482, 5865760.136383352801204 ], [ 1389870.225675179390237, 5865760.136383352801204 ], [ 1389777.459432851755992, 5865760.136383352801204 ], [ 1389684.693190524121746, 5865760.136383352801204 ], [ 1389591.926948196487501, 5865760.136383352801204 ], [ 1389499.160705868853256, 5865625.296765649691224 ], [ 1389406.39446354098618, 5865625.296765649691224 ], [ 1389406.39446354098618, 5865490.459216705523431 ], [ 1389313.628221213351935, 5865355.623736422508955 ], [ 1389313.628221213351935, 5865220.790324714966118 ], [ 1389313.628221213351935, 5865085.958981488831341 ], [ 1389220.86197888571769, 5864951.129706650041044 ], [ 1389128.095736558316275, 5864816.302500107325613 ], [ 1389128.095736558316275, 5864681.477361769415438 ], [ 1389035.32949423068203, 5864546.654291545972228 ], [ 1389128.095736558316275, 5864411.833289342001081 ], [ 1389128.095736558316275, 5864277.014355068095028 ], [ 1389035.32949423068203, 5864142.197488628327847 ], [ 1388942.563251903047785, 5864007.382689936086535 ], [ 1388849.797009575180709, 5863872.569958896376193 ], [ 1388757.030767247546464, 5863872.569958896376193 ], [ 1388664.264524919912219, 5863737.759295416995883 ], [ 1388571.498282592277974, 5863602.950699406675994 ], [ 1388571.498282592277974, 5863468.144170773215592 ], [ 1388571.498282592277974, 5863333.339709427207708 ], [ 1388478.732040264643729, 5863333.339709427207708 ], [ 1388385.965797937009484, 5863198.537315272726119 ], [ 1388293.199555609375238, 5863198.537315272726119 ], [ 1388200.433313281740993, 5863198.537315272726119 ], [ 1388107.667070954106748, 5863063.736988220363855 ], [ 1388014.900828626472503, 5863063.736988220363855 ], [ 1387922.134586298838258, 5863063.736988220363855 ], [ 1387829.368343971204013, 5862928.938728176057339 ], [ 1387736.602101643569767, 5862794.142535050399601 ], [ 1387736.602101643569767, 5862659.348408752121031 ], [ 1387736.602101643569767, 5862524.556349185295403 ], [ 1387643.835859315935522, 5862389.766356259584427 ], [ 1387551.069616988068447, 5862254.978429886512458 ], [ 1387458.303374660667032, 5862254.978429886512458 ], [ 1387365.537132333032787, 5862254.978429886512458 ], [ 1387272.770890005398542, 5862254.978429886512458 ], [ 1387180.004647677764297, 5862254.978429886512458 ], [ 1387087.238405350130051, 5862254.978429886512458 ], [ 1386994.472163022495806, 5862120.192569970153272 ] ] } }, -{ "type": "Feature", "properties": { "height": 13.574996948242188, "width": 63.595319, "bedlev": 813.29998779296875, "branchid": "river_2", "branchtype": "river", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_2", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386066.809739745920524, 5868052.726493230089545 ], [ 1386159.575982073554769, 5868052.726493230089545 ], [ 1386252.342224401189014, 5867917.851692584343255 ], [ 1386345.108466728823259, 5867917.851692584343255 ], [ 1386437.874709056690335, 5867917.851692584343255 ], [ 1386530.64095138432458, 5867917.851692584343255 ], [ 1386623.407193711958826, 5867917.851692584343255 ], [ 1386716.17343603936024, 5867782.978962258435786 ], [ 1386808.939678366994485, 5867782.978962258435786 ], [ 1386901.70592069462873, 5867782.978962258435786 ], [ 1386994.472163022495806, 5867648.108302162960172 ], [ 1387087.238405350130051, 5867648.108302162960172 ], [ 1387180.004647677764297, 5867513.239712204784155 ], [ 1387272.770890005398542, 5867378.373192292638123 ], [ 1387365.537132333032787, 5867243.508742331527174 ], [ 1387458.303374660667032, 5867108.646362232975662 ], [ 1387551.069616988068447, 5867108.646362232975662 ], [ 1387643.835859315935522, 5867108.646362232975662 ], [ 1387736.602101643569767, 5866973.78605190385133 ], [ 1387829.368343971204013, 5866973.78605190385133 ], [ 1387829.368343971204013, 5866838.927811251021922 ], [ 1387829.368343971204013, 5866704.071640183217824 ], [ 1387829.368343971204013, 5866569.217538607306778 ], [ 1387922.134586298838258, 5866434.365506432950497 ], [ 1387922.134586298838258, 5866299.515543567948043 ], [ 1388014.900828626472503, 5866164.667649918235838 ], [ 1388014.900828626472503, 5866029.821825394406915 ], [ 1388014.900828626472503, 5865894.978069902397692 ], [ 1388014.900828626472503, 5865760.136383352801204 ], [ 1387922.134586298838258, 5865625.296765649691224 ], [ 1387922.134586298838258, 5865490.459216705523431 ], [ 1387922.134586298838258, 5865355.623736422508955 ], [ 1387922.134586298838258, 5865220.790324714966118 ], [ 1387922.134586298838258, 5865085.958981488831341 ], [ 1387829.368343971204013, 5864951.129706650041044 ], [ 1387829.368343971204013, 5864816.302500107325613 ], [ 1387829.368343971204013, 5864681.477361769415438 ], [ 1387829.368343971204013, 5864546.654291545972228 ], [ 1387829.368343971204013, 5864411.833289342001081 ], [ 1387829.368343971204013, 5864277.014355068095028 ], [ 1387736.602101643569767, 5864142.197488628327847 ], [ 1387643.835859315935522, 5864007.382689936086535 ], [ 1387551.069616988068447, 5863872.569958896376193 ], [ 1387551.069616988068447, 5863737.759295416995883 ], [ 1387458.303374660667032, 5863602.950699406675994 ], [ 1387365.537132333032787, 5863468.144170773215592 ], [ 1387272.770890005398542, 5863333.339709427207708 ], [ 1387272.770890005398542, 5863198.537315272726119 ], [ 1387180.004647677764297, 5863063.736988220363855 ], [ 1387087.238405350130051, 5862928.938728176057339 ], [ 1386994.472163022495806, 5862794.142535050399601 ], [ 1386901.70592069462873, 5862794.142535050399601 ], [ 1386808.939678366994485, 5862659.348408752121031 ], [ 1386716.17343603936024, 5862524.556349185295403 ], [ 1386716.17343603936024, 5862389.766356259584427 ], [ 1386716.17343603936024, 5862254.978429886512458 ], [ 1386808.939678366994485, 5862254.978429886512458 ], [ 1386901.70592069462873, 5862120.192569970153272 ], [ 1386994.472163022495806, 5862120.192569970153272 ] ] } }, -{ "type": "Feature", "properties": { "height": 21.70001220703125, "width": 50.0, "bedlev": 952.79998779296875, "branchid": "river_3", "branchtype": "river", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_3", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1391540.01803707703948, 5858077.577220032922924 ], [ 1391447.251794749405235, 5858077.577220032922924 ], [ 1391354.48555242177099, 5858077.577220032922924 ], [ 1391261.719310093903914, 5858077.577220032922924 ], [ 1391168.953067766269669, 5858077.577220032922924 ], [ 1391076.186825438635424, 5858212.301128903403878 ], [ 1390983.420583111001179, 5858212.301128903403878 ], [ 1390890.654340783366933, 5858212.301128903403878 ], [ 1390797.888098455965519, 5858077.577220032922924 ], [ 1390705.121856128098443, 5858077.577220032922924 ], [ 1390612.355613800464198, 5858077.577220032922924 ], [ 1390519.589371472829953, 5858077.577220032922924 ], [ 1390426.823129145195708, 5858077.577220032922924 ], [ 1390334.056886817561463, 5857942.855374777689576 ], [ 1390241.290644489927217, 5857942.855374777689576 ], [ 1390148.524402162292972, 5857942.855374777689576 ], [ 1390055.758159834658727, 5857808.135593040846288 ], [ 1389962.991917507024482, 5857808.135593040846288 ], [ 1389962.991917507024482, 5857673.41787473578006 ], [ 1389870.225675179390237, 5857673.41787473578006 ], [ 1389777.459432851755992, 5857673.41787473578006 ], [ 1389684.693190524121746, 5857808.135593040846288 ], [ 1389591.926948196487501, 5857808.135593040846288 ], [ 1389499.160705868853256, 5857808.135593040846288 ], [ 1389406.39446354098618, 5857808.135593040846288 ], [ 1389313.628221213351935, 5857942.855374777689576 ], [ 1389220.86197888571769, 5858077.577220032922924 ], [ 1389128.095736558316275, 5858212.301128903403878 ], [ 1389035.32949423068203, 5858212.301128903403878 ], [ 1388942.563251903047785, 5858347.02710147574544 ], [ 1388849.797009575180709, 5858347.02710147574544 ], [ 1388757.030767247546464, 5858347.02710147574544 ], [ 1388664.264524919912219, 5858481.755137845873833 ], [ 1388571.498282592277974, 5858481.755137845873833 ], [ 1388478.732040264643729, 5858481.755137845873833 ], [ 1388385.965797937009484, 5858481.755137845873833 ], [ 1388293.199555609375238, 5858481.755137845873833 ], [ 1388200.433313281740993, 5858616.485238100402057 ], [ 1388107.667070954106748, 5858751.217402336187661 ], [ 1388014.900828626472503, 5858885.951630645431578 ], [ 1387922.134586298838258, 5858885.951630645431578 ], [ 1387829.368343971204013, 5858885.951630645431578 ], [ 1387736.602101643569767, 5858885.951630645431578 ], [ 1387643.835859315935522, 5858885.951630645431578 ], [ 1387551.069616988068447, 5858885.951630645431578 ], [ 1387458.303374660667032, 5858885.951630645431578 ], [ 1387365.537132333032787, 5858885.951630645431578 ], [ 1387272.770890005398542, 5858885.951630645431578 ], [ 1387180.004647677764297, 5858885.951630645431578 ], [ 1387087.238405350130051, 5858885.951630645431578 ], [ 1386994.472163022495806, 5858885.951630645431578 ], [ 1386901.70592069462873, 5858885.951630645431578 ], [ 1386808.939678366994485, 5858885.951630645431578 ], [ 1386716.17343603936024, 5859020.687923114746809 ], [ 1386623.407193711958826, 5859020.687923114746809 ], [ 1386530.64095138432458, 5859020.687923114746809 ], [ 1386437.874709056690335, 5859020.687923114746809 ], [ 1386345.108466728823259, 5859020.687923114746809 ] ] } }, -{ "type": "Feature", "properties": { "height": 14.050003051757812, "width": 60.93007025, "bedlev": 724.29998779296875, "branchid": "river_4", "branchtype": "river", "branchorder": "1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_4", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386994.472163022495806, 5862120.192569970153272 ], [ 1386901.70592069462873, 5861985.408776421099901 ], [ 1386808.939678366994485, 5861850.627049146220088 ], [ 1386716.17343603936024, 5861715.847388052381575 ], [ 1386716.17343603936024, 5861581.069793051108718 ], [ 1386716.17343603936024, 5861446.294264048337936 ], [ 1386648.271799877518788, 5861347.644815167412162 ] ] } }, -{ "type": "Feature", "properties": { "height": 14.050003051757812, "width": 60.93007025, "bedlev": 724.29998779296875, "branchid": "river_4-1", "branchtype": "river", "branchorder": "1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_4", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386648.271799877518788, 5861347.644815167412162 ], [ 1386623.407193711958826, 5861311.520800951868296 ], [ 1386623.407193711958826, 5861176.749403670430183 ], [ 1386530.64095138432458, 5861176.749403670430183 ], [ 1386437.874709056690335, 5861041.98007211368531 ], [ 1386437.874709056690335, 5860907.212806186638772 ], [ 1386437.874709056690335, 5860772.447605801746249 ], [ 1386437.874709056690335, 5860637.684470863081515 ], [ 1386345.108466728823259, 5860502.92340128030628 ], [ 1386345.108466728823259, 5860368.164396961219609 ], [ 1386252.342224401189014, 5860233.407457816414535 ], [ 1386159.575982073554769, 5860098.652583750896156 ], [ 1386159.575982073554769, 5859963.899774673394859 ], [ 1386159.575982073554769, 5859829.149030494503677 ], [ 1386159.575982073554769, 5859694.40035112015903 ], [ 1386252.342224401189014, 5859559.653736459091306 ], [ 1386252.342224401189014, 5859424.909186420030892 ], [ 1386252.342224401189014, 5859290.166700910776854 ], [ 1386252.342224401189014, 5859155.426279840059578 ], [ 1386345.108466728823259, 5859020.687923114746809 ] ] } }, -{ "type": "Feature", "properties": { "height": 17.349960327148438, "width": 60.93007025, "bedlev": 701.4000244140625, "branchid": "river_5", "branchtype": "river", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_5", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386345.108466728823259, 5859020.687923114746809 ], [ 1386252.342224401189014, 5858885.951630645431578 ], [ 1386159.575982073554769, 5858751.217402336187661 ], [ 1386159.575982073554769, 5858616.485238100402057 ], [ 1386159.575982073554769, 5858481.755137845873833 ], [ 1386159.575982073554769, 5858347.02710147574544 ], [ 1386066.809739745920524, 5858212.301128903403878 ], [ 1385974.043497418286279, 5858212.301128903403878 ], [ 1385881.277255090652034, 5858212.301128903403878 ], [ 1385788.511012763017789, 5858212.301128903403878 ], [ 1385695.744770435383543, 5858212.301128903403878 ], [ 1385602.978528107749298, 5858077.577220032922924 ], [ 1385510.212285780115053, 5857942.855374777689576 ], [ 1385510.212285780115053, 5857808.135593040846288 ], [ 1385417.446043452480808, 5857673.41787473578006 ], [ 1385324.679801124846563, 5857673.41787473578006 ], [ 1385231.913558797212318, 5857538.702219764702022 ], [ 1385231.913558797212318, 5857403.988628041930497 ], [ 1385231.913558797212318, 5857269.277099471539259 ], [ 1385231.913558797212318, 5857134.567633965052664 ], [ 1385324.679801124846563, 5856999.86023142747581 ], [ 1385231.913558797212318, 5856865.154891769401729 ], [ 1385231.913558797212318, 5856730.451614898629487 ], [ 1385139.147316469578072, 5856595.750400722958148 ], [ 1385046.381074141710997, 5856595.750400722958148 ], [ 1384953.614831814309582, 5856461.051249152049422 ], [ 1384860.848589486675337, 5856461.051249152049422 ], [ 1384768.082347159041092, 5856326.354160091839731 ], [ 1384768.082347159041092, 5856191.659133453853428 ], [ 1384675.316104831406847, 5856056.966169144026935 ], [ 1384582.549862503772601, 5856056.966169144026935 ], [ 1384489.783620175905526, 5855922.275267072021961 ], [ 1384397.017377848271281, 5855787.586427145637572 ], [ 1384304.251135520637035, 5855787.586427145637572 ], [ 1384211.48489319300279, 5855652.899649272672832 ], [ 1384118.718650865368545, 5855518.21493336185813 ], [ 1384025.952408537967131, 5855383.532279322855175 ], [ 1383933.186166210100055, 5855248.851687061600387 ], [ 1383840.41992388246581, 5855248.851687061600387 ], [ 1383747.653681554831564, 5855114.1731564886868 ], [ 1383747.653681554831564, 5854979.496687510982156 ], [ 1383747.653681554831564, 5854844.822280039079487 ], [ 1383654.887439227197319, 5854844.822280039079487 ], [ 1383562.121196899563074, 5854710.149933977983892 ], [ 1383469.354954571928829, 5854710.149933977983892 ], [ 1383376.588712244294584, 5854575.479649240151048 ], [ 1383283.822469916660339, 5854440.811425729654729 ], [ 1383191.056227589026093, 5854440.811425729654729 ] ] } } +{ "type": "Feature", "properties": { "height": 22.5, "bedlev": 865.60003662109375, "width": 60.500781333333329, "branchid": "river_1", "branchtype": "river", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_1", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1394694.070276216836646, 5867648.108302162960172 ], [ 1394694.070276216836646, 5867513.239712204784155 ], [ 1394601.304033889202401, 5867378.373192292638123 ], [ 1394508.537791561568156, 5867243.508742331527174 ], [ 1394415.771549233933911, 5867243.508742331527174 ], [ 1394323.005306906066835, 5867108.646362232975662 ], [ 1394230.23906457843259, 5867108.646362232975662 ], [ 1394137.472822251031175, 5867108.646362232975662 ], [ 1394044.70657992339693, 5866973.78605190385133 ], [ 1393951.940337595762685, 5866973.78605190385133 ], [ 1393859.17409526812844, 5866973.78605190385133 ], [ 1393766.407852940494195, 5866838.927811251021922 ], [ 1393673.641610612627119, 5866838.927811251021922 ], [ 1393580.875368284992874, 5866838.927811251021922 ], [ 1393488.109125957358629, 5866838.927811251021922 ], [ 1393395.342883629724383, 5866838.927811251021922 ], [ 1393302.576641302322969, 5866838.927811251021922 ], [ 1393209.810398974688724, 5866838.927811251021922 ], [ 1393117.044156646821648, 5866704.071640183217824 ], [ 1393024.277914319187403, 5866704.071640183217824 ], [ 1392931.511671991553158, 5866704.071640183217824 ], [ 1392838.745429663918912, 5866704.071640183217824 ], [ 1392745.979187336284667, 5866569.217538607306778 ], [ 1392653.212945008650422, 5866569.217538607306778 ], [ 1392560.446702681016177, 5866569.217538607306778 ], [ 1392467.680460353381932, 5866569.217538607306778 ], [ 1392374.914218025747687, 5866569.217538607306778 ], [ 1392282.147975698113441, 5866434.365506432950497 ], [ 1392189.381733370479196, 5866299.515543567948043 ], [ 1392096.615491042844951, 5866299.515543567948043 ], [ 1392003.849248715210706, 5866299.515543567948043 ], [ 1391911.083006387576461, 5866299.515543567948043 ], [ 1391818.316764059709385, 5866164.667649918235838 ], [ 1391725.55052173207514, 5866164.667649918235838 ], [ 1391632.784279404673725, 5866164.667649918235838 ], [ 1391540.01803707703948, 5866164.667649918235838 ], [ 1391447.251794749405235, 5866164.667649918235838 ], [ 1391354.48555242177099, 5866164.667649918235838 ], [ 1391261.719310093903914, 5866164.667649918235838 ], [ 1391168.953067766269669, 5866164.667649918235838 ], [ 1391076.186825438635424, 5866164.667649918235838 ], [ 1390983.420583111001179, 5866164.667649918235838 ], [ 1390890.654340783366933, 5866164.667649918235838 ], [ 1390797.888098455965519, 5866029.821825394406915 ], [ 1390705.121856128098443, 5866029.821825394406915 ], [ 1390612.355613800464198, 5866029.821825394406915 ], [ 1390519.589371472829953, 5866029.821825394406915 ], [ 1390426.823129145195708, 5866029.821825394406915 ], [ 1390334.056886817561463, 5866029.821825394406915 ], [ 1390241.290644489927217, 5866029.821825394406915 ], [ 1390148.524402162292972, 5865894.978069902397692 ], [ 1390055.758159834658727, 5865894.978069902397692 ], [ 1389962.991917507024482, 5865760.136383352801204 ], [ 1389870.225675179390237, 5865760.136383352801204 ], [ 1389777.459432851755992, 5865760.136383352801204 ], [ 1389684.693190524121746, 5865760.136383352801204 ], [ 1389591.926948196487501, 5865760.136383352801204 ], [ 1389499.160705868853256, 5865625.296765649691224 ], [ 1389406.39446354098618, 5865625.296765649691224 ], [ 1389406.39446354098618, 5865490.459216705523431 ], [ 1389313.628221213351935, 5865355.623736422508955 ], [ 1389313.628221213351935, 5865220.790324714966118 ], [ 1389313.628221213351935, 5865085.958981488831341 ], [ 1389220.86197888571769, 5864951.129706650041044 ], [ 1389128.095736558316275, 5864816.302500107325613 ], [ 1389128.095736558316275, 5864681.477361769415438 ], [ 1389035.32949423068203, 5864546.654291545972228 ], [ 1389128.095736558316275, 5864411.833289342001081 ], [ 1389128.095736558316275, 5864277.014355068095028 ], [ 1389035.32949423068203, 5864142.197488628327847 ], [ 1388942.563251903047785, 5864007.382689936086535 ], [ 1388849.797009575180709, 5863872.569958896376193 ], [ 1388757.030767247546464, 5863872.569958896376193 ], [ 1388664.264524919912219, 5863737.759295416995883 ], [ 1388571.498282592277974, 5863602.950699406675994 ], [ 1388571.498282592277974, 5863468.144170773215592 ], [ 1388571.498282592277974, 5863333.339709427207708 ], [ 1388478.732040264643729, 5863333.339709427207708 ], [ 1388385.965797937009484, 5863198.537315272726119 ], [ 1388293.199555609375238, 5863198.537315272726119 ], [ 1388200.433313281740993, 5863198.537315272726119 ], [ 1388107.667070954106748, 5863063.736988220363855 ], [ 1388014.900828626472503, 5863063.736988220363855 ], [ 1387922.134586298838258, 5863063.736988220363855 ], [ 1387829.368343971204013, 5862928.938728176057339 ], [ 1387736.602101643569767, 5862794.142535050399601 ], [ 1387736.602101643569767, 5862659.348408752121031 ], [ 1387736.602101643569767, 5862524.556349185295403 ], [ 1387643.835859315935522, 5862389.766356259584427 ], [ 1387551.069616988068447, 5862254.978429886512458 ], [ 1387458.303374660667032, 5862254.978429886512458 ], [ 1387365.537132333032787, 5862254.978429886512458 ], [ 1387272.770890005398542, 5862254.978429886512458 ], [ 1387180.004647677764297, 5862254.978429886512458 ], [ 1387087.238405350130051, 5862254.978429886512458 ], [ 1386994.472163022495806, 5862120.192569970153272 ] ] } }, +{ "type": "Feature", "properties": { "height": 13.574996948242188, "bedlev": 813.29998779296875, "width": 63.595319, "branchid": "river_2", "branchtype": "river", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_2", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386066.809739745920524, 5868052.726493230089545 ], [ 1386159.575982073554769, 5868052.726493230089545 ], [ 1386252.342224401189014, 5867917.851692584343255 ], [ 1386345.108466728823259, 5867917.851692584343255 ], [ 1386437.874709056690335, 5867917.851692584343255 ], [ 1386530.64095138432458, 5867917.851692584343255 ], [ 1386623.407193711958826, 5867917.851692584343255 ], [ 1386716.17343603936024, 5867782.978962258435786 ], [ 1386808.939678366994485, 5867782.978962258435786 ], [ 1386901.70592069462873, 5867782.978962258435786 ], [ 1386994.472163022495806, 5867648.108302162960172 ], [ 1387087.238405350130051, 5867648.108302162960172 ], [ 1387180.004647677764297, 5867513.239712204784155 ], [ 1387272.770890005398542, 5867378.373192292638123 ], [ 1387365.537132333032787, 5867243.508742331527174 ], [ 1387458.303374660667032, 5867108.646362232975662 ], [ 1387551.069616988068447, 5867108.646362232975662 ], [ 1387643.835859315935522, 5867108.646362232975662 ], [ 1387736.602101643569767, 5866973.78605190385133 ], [ 1387829.368343971204013, 5866973.78605190385133 ], [ 1387829.368343971204013, 5866838.927811251021922 ], [ 1387829.368343971204013, 5866704.071640183217824 ], [ 1387829.368343971204013, 5866569.217538607306778 ], [ 1387922.134586298838258, 5866434.365506432950497 ], [ 1387922.134586298838258, 5866299.515543567948043 ], [ 1388014.900828626472503, 5866164.667649918235838 ], [ 1388014.900828626472503, 5866029.821825394406915 ], [ 1388014.900828626472503, 5865894.978069902397692 ], [ 1388014.900828626472503, 5865760.136383352801204 ], [ 1387922.134586298838258, 5865625.296765649691224 ], [ 1387922.134586298838258, 5865490.459216705523431 ], [ 1387922.134586298838258, 5865355.623736422508955 ], [ 1387922.134586298838258, 5865220.790324714966118 ], [ 1387922.134586298838258, 5865085.958981488831341 ], [ 1387829.368343971204013, 5864951.129706650041044 ], [ 1387829.368343971204013, 5864816.302500107325613 ], [ 1387829.368343971204013, 5864681.477361769415438 ], [ 1387829.368343971204013, 5864546.654291545972228 ], [ 1387829.368343971204013, 5864411.833289342001081 ], [ 1387829.368343971204013, 5864277.014355068095028 ], [ 1387736.602101643569767, 5864142.197488628327847 ], [ 1387643.835859315935522, 5864007.382689936086535 ], [ 1387551.069616988068447, 5863872.569958896376193 ], [ 1387551.069616988068447, 5863737.759295416995883 ], [ 1387458.303374660667032, 5863602.950699406675994 ], [ 1387365.537132333032787, 5863468.144170773215592 ], [ 1387272.770890005398542, 5863333.339709427207708 ], [ 1387272.770890005398542, 5863198.537315272726119 ], [ 1387180.004647677764297, 5863063.736988220363855 ], [ 1387087.238405350130051, 5862928.938728176057339 ], [ 1386994.472163022495806, 5862794.142535050399601 ], [ 1386901.70592069462873, 5862794.142535050399601 ], [ 1386808.939678366994485, 5862659.348408752121031 ], [ 1386716.17343603936024, 5862524.556349185295403 ], [ 1386716.17343603936024, 5862389.766356259584427 ], [ 1386716.17343603936024, 5862254.978429886512458 ], [ 1386808.939678366994485, 5862254.978429886512458 ], [ 1386901.70592069462873, 5862120.192569970153272 ], [ 1386994.472163022495806, 5862120.192569970153272 ] ] } }, +{ "type": "Feature", "properties": { "height": 21.70001220703125, "bedlev": 952.79998779296875, "width": 50.0, "branchid": "river_3", "branchtype": "river", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_3", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1391540.01803707703948, 5858077.577220032922924 ], [ 1391447.251794749405235, 5858077.577220032922924 ], [ 1391354.48555242177099, 5858077.577220032922924 ], [ 1391261.719310093903914, 5858077.577220032922924 ], [ 1391168.953067766269669, 5858077.577220032922924 ], [ 1391076.186825438635424, 5858212.301128903403878 ], [ 1390983.420583111001179, 5858212.301128903403878 ], [ 1390890.654340783366933, 5858212.301128903403878 ], [ 1390797.888098455965519, 5858077.577220032922924 ], [ 1390705.121856128098443, 5858077.577220032922924 ], [ 1390612.355613800464198, 5858077.577220032922924 ], [ 1390519.589371472829953, 5858077.577220032922924 ], [ 1390426.823129145195708, 5858077.577220032922924 ], [ 1390334.056886817561463, 5857942.855374777689576 ], [ 1390241.290644489927217, 5857942.855374777689576 ], [ 1390148.524402162292972, 5857942.855374777689576 ], [ 1390055.758159834658727, 5857808.135593040846288 ], [ 1389962.991917507024482, 5857808.135593040846288 ], [ 1389962.991917507024482, 5857673.41787473578006 ], [ 1389870.225675179390237, 5857673.41787473578006 ], [ 1389777.459432851755992, 5857673.41787473578006 ], [ 1389684.693190524121746, 5857808.135593040846288 ], [ 1389591.926948196487501, 5857808.135593040846288 ], [ 1389499.160705868853256, 5857808.135593040846288 ], [ 1389406.39446354098618, 5857808.135593040846288 ], [ 1389313.628221213351935, 5857942.855374777689576 ], [ 1389220.86197888571769, 5858077.577220032922924 ], [ 1389128.095736558316275, 5858212.301128903403878 ], [ 1389035.32949423068203, 5858212.301128903403878 ], [ 1388942.563251903047785, 5858347.02710147574544 ], [ 1388849.797009575180709, 5858347.02710147574544 ], [ 1388757.030767247546464, 5858347.02710147574544 ], [ 1388664.264524919912219, 5858481.755137845873833 ], [ 1388571.498282592277974, 5858481.755137845873833 ], [ 1388478.732040264643729, 5858481.755137845873833 ], [ 1388385.965797937009484, 5858481.755137845873833 ], [ 1388293.199555609375238, 5858481.755137845873833 ], [ 1388200.433313281740993, 5858616.485238100402057 ], [ 1388107.667070954106748, 5858751.217402336187661 ], [ 1388014.900828626472503, 5858885.951630645431578 ], [ 1387922.134586298838258, 5858885.951630645431578 ], [ 1387829.368343971204013, 5858885.951630645431578 ], [ 1387736.602101643569767, 5858885.951630645431578 ], [ 1387643.835859315935522, 5858885.951630645431578 ], [ 1387551.069616988068447, 5858885.951630645431578 ], [ 1387458.303374660667032, 5858885.951630645431578 ], [ 1387365.537132333032787, 5858885.951630645431578 ], [ 1387272.770890005398542, 5858885.951630645431578 ], [ 1387180.004647677764297, 5858885.951630645431578 ], [ 1387087.238405350130051, 5858885.951630645431578 ], [ 1386994.472163022495806, 5858885.951630645431578 ], [ 1386901.70592069462873, 5858885.951630645431578 ], [ 1386808.939678366994485, 5858885.951630645431578 ], [ 1386716.17343603936024, 5859020.687923114746809 ], [ 1386623.407193711958826, 5859020.687923114746809 ], [ 1386530.64095138432458, 5859020.687923114746809 ], [ 1386437.874709056690335, 5859020.687923114746809 ], [ 1386345.108466728823259, 5859020.687923114746809 ] ] } }, +{ "type": "Feature", "properties": { "height": 14.050003051757812, "bedlev": 724.29998779296875, "width": 60.93007025, "branchid": "river_4", "branchtype": "river", "branchorder": "1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_4", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386994.472163022495806, 5862120.192569970153272 ], [ 1386901.70592069462873, 5861985.408776421099901 ], [ 1386808.939678366994485, 5861850.627049146220088 ], [ 1386716.17343603936024, 5861715.847388052381575 ], [ 1386716.17343603936024, 5861581.069793051108718 ], [ 1386716.17343603936024, 5861446.294264048337936 ], [ 1386648.271799877518788, 5861347.644815167412162 ] ] } }, +{ "type": "Feature", "properties": { "height": 14.050003051757812, "bedlev": 724.29998779296875, "width": 60.93007025, "branchid": "river_4-1", "branchtype": "river", "branchorder": "1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_4", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386648.271799877518788, 5861347.644815167412162 ], [ 1386623.407193711958826, 5861311.520800951868296 ], [ 1386623.407193711958826, 5861176.749403670430183 ], [ 1386530.64095138432458, 5861176.749403670430183 ], [ 1386437.874709056690335, 5861041.98007211368531 ], [ 1386437.874709056690335, 5860907.212806186638772 ], [ 1386437.874709056690335, 5860772.447605801746249 ], [ 1386437.874709056690335, 5860637.684470863081515 ], [ 1386345.108466728823259, 5860502.92340128030628 ], [ 1386345.108466728823259, 5860368.164396961219609 ], [ 1386252.342224401189014, 5860233.407457816414535 ], [ 1386159.575982073554769, 5860098.652583750896156 ], [ 1386159.575982073554769, 5859963.899774673394859 ], [ 1386159.575982073554769, 5859829.149030494503677 ], [ 1386159.575982073554769, 5859694.40035112015903 ], [ 1386252.342224401189014, 5859559.653736459091306 ], [ 1386252.342224401189014, 5859424.909186420030892 ], [ 1386252.342224401189014, 5859290.166700910776854 ], [ 1386252.342224401189014, 5859155.426279840059578 ], [ 1386345.108466728823259, 5859020.687923114746809 ] ] } }, +{ "type": "Feature", "properties": { "height": 17.349960327148438, "bedlev": 701.4000244140625, "width": 60.93007025, "branchid": "river_5", "branchtype": "river", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_5", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386345.108466728823259, 5859020.687923114746809 ], [ 1386252.342224401189014, 5858885.951630645431578 ], [ 1386159.575982073554769, 5858751.217402336187661 ], [ 1386159.575982073554769, 5858616.485238100402057 ], [ 1386159.575982073554769, 5858481.755137845873833 ], [ 1386159.575982073554769, 5858347.02710147574544 ], [ 1386066.809739745920524, 5858212.301128903403878 ], [ 1385974.043497418286279, 5858212.301128903403878 ], [ 1385881.277255090652034, 5858212.301128903403878 ], [ 1385788.511012763017789, 5858212.301128903403878 ], [ 1385695.744770435383543, 5858212.301128903403878 ], [ 1385602.978528107749298, 5858077.577220032922924 ], [ 1385510.212285780115053, 5857942.855374777689576 ], [ 1385510.212285780115053, 5857808.135593040846288 ], [ 1385417.446043452480808, 5857673.41787473578006 ], [ 1385324.679801124846563, 5857673.41787473578006 ], [ 1385231.913558797212318, 5857538.702219764702022 ], [ 1385231.913558797212318, 5857403.988628041930497 ], [ 1385231.913558797212318, 5857269.277099471539259 ], [ 1385231.913558797212318, 5857134.567633965052664 ], [ 1385324.679801124846563, 5856999.86023142747581 ], [ 1385231.913558797212318, 5856865.154891769401729 ], [ 1385231.913558797212318, 5856730.451614898629487 ], [ 1385139.147316469578072, 5856595.750400722958148 ], [ 1385046.381074141710997, 5856595.750400722958148 ], [ 1384953.614831814309582, 5856461.051249152049422 ], [ 1384860.848589486675337, 5856461.051249152049422 ], [ 1384768.082347159041092, 5856326.354160091839731 ], [ 1384768.082347159041092, 5856191.659133453853428 ], [ 1384675.316104831406847, 5856056.966169144026935 ], [ 1384582.549862503772601, 5856056.966169144026935 ], [ 1384489.783620175905526, 5855922.275267072021961 ], [ 1384397.017377848271281, 5855787.586427145637572 ], [ 1384304.251135520637035, 5855787.586427145637572 ], [ 1384211.48489319300279, 5855652.899649272672832 ], [ 1384118.718650865368545, 5855518.21493336185813 ], [ 1384025.952408537967131, 5855383.532279322855175 ], [ 1383933.186166210100055, 5855248.851687061600387 ], [ 1383840.41992388246581, 5855248.851687061600387 ], [ 1383747.653681554831564, 5855114.1731564886868 ], [ 1383747.653681554831564, 5854979.496687510982156 ], [ 1383747.653681554831564, 5854844.822280039079487 ], [ 1383654.887439227197319, 5854844.822280039079487 ], [ 1383562.121196899563074, 5854710.149933977983892 ], [ 1383469.354954571928829, 5854710.149933977983892 ], [ 1383376.588712244294584, 5854575.479649240151048 ], [ 1383283.822469916660339, 5854440.811425729654729 ], [ 1383191.056227589026093, 5854440.811425729654729 ] ] } } ] } diff --git a/examples/dflowfm_piave/geoms/rivers_nodes.geojson b/examples/dflowfm_piave/geoms/rivers_nodes.geojson index d387d4e2..c402a527 100644 --- a/examples/dflowfm_piave/geoms/rivers_nodes.geojson +++ b/examples/dflowfm_piave/geoms/rivers_nodes.geojson @@ -2,11 +2,11 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::3857" } }, "features": [ -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_0", "branch_id": "river_1", "height": 22.5, "width": 60.500781333333329, "bedlev": 865.60003662109375, "branchid": "river_1", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_1" }, "geometry": { "type": "Point", "coordinates": [ 1394694.070276216836646, 5867648.108302162960172 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_1", "branch_id": "river_1", "height": 22.5, "width": 60.500781333333329, "bedlev": 865.60003662109375, "branchid": "river_1", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_1" }, "geometry": { "type": "Point", "coordinates": [ 1386994.472163022495806, 5862120.192569970153272 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_2", "branch_id": "river_2", "height": 13.574996948242188, "width": 63.595319, "bedlev": 813.29998779296875, "branchid": "river_2", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_2" }, "geometry": { "type": "Point", "coordinates": [ 1386066.809739745920524, 5868052.726493230089545 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_3", "branch_id": "river_3", "height": 21.70001220703125, "width": 50.0, "bedlev": 952.79998779296875, "branchid": "river_3", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_3" }, "geometry": { "type": "Point", "coordinates": [ 1391540.01803707703948, 5858077.577220032922924 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_4", "branch_id": "river_3", "height": 21.70001220703125, "width": 50.0, "bedlev": 952.79998779296875, "branchid": "river_3", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_3" }, "geometry": { "type": "Point", "coordinates": [ 1386345.108466728823259, 5859020.687923114746809 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_5", "branch_id": "river_5", "height": 17.349960327148438, "width": 60.93007025, "bedlev": 701.4000244140625, "branchid": "river_5", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_5" }, "geometry": { "type": "Point", "coordinates": [ 1383191.056227589026093, 5854440.811425729654729 ] } } +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_0", "branch_id": "river_1", "height": 22.5, "bedlev": 865.60003662109375, "width": 60.500781333333329, "branchid": "river_1", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_1" }, "geometry": { "type": "Point", "coordinates": [ 1394694.070276216836646, 5867648.108302162960172 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_1", "branch_id": "river_1", "height": 22.5, "bedlev": 865.60003662109375, "width": 60.500781333333329, "branchid": "river_1", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_1" }, "geometry": { "type": "Point", "coordinates": [ 1386994.472163022495806, 5862120.192569970153272 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_2", "branch_id": "river_2", "height": 13.574996948242188, "bedlev": 813.29998779296875, "width": 63.595319, "branchid": "river_2", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_2" }, "geometry": { "type": "Point", "coordinates": [ 1386066.809739745920524, 5868052.726493230089545 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_3", "branch_id": "river_3", "height": 21.70001220703125, "bedlev": 952.79998779296875, "width": 50.0, "branchid": "river_3", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_3" }, "geometry": { "type": "Point", "coordinates": [ 1391540.01803707703948, 5858077.577220032922924 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_4", "branch_id": "river_3", "height": 21.70001220703125, "bedlev": 952.79998779296875, "width": 50.0, "branchid": "river_3", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_3" }, "geometry": { "type": "Point", "coordinates": [ 1386345.108466728823259, 5859020.687923114746809 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_5", "branch_id": "river_5", "height": 17.349960327148438, "bedlev": 701.4000244140625, "width": 60.93007025, "branchid": "river_5", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_5" }, "geometry": { "type": "Point", "coordinates": [ 1383191.056227589026093, 5854440.811425729654729 ] } } ] } diff --git a/hydromt_delft3dfm/utils.py b/hydromt_delft3dfm/utils.py index 2dbece64..011e0802 100644 --- a/hydromt_delft3dfm/utils.py +++ b/hydromt_delft3dfm/utils.py @@ -194,9 +194,10 @@ def _list2Str(lst): # convert list to str () df_crsdef = df_crsdef.applymap(lambda x: _list2Str(x)) # except for frictionids - df_crsdef["frictionids"] = df_crsdef["frictionids"].str.replace( - " ", ";" - ) # comma list sperated + if "frictionids" in df_crsdef.columns: + df_crsdef["frictionids"] = df_crsdef["frictionids"].str.replace( + " ", ";" + ) # comma list sperated # convert float to int int_columns = list( set(df_crsdef.columns).intersection(("xyzcount", "sectioncount")) @@ -384,20 +385,28 @@ def write_friction(gdf: gpd.GeoDataFrame, savedir: str) -> List[str]: friction_fns: List of str list of relative filepaths to friction files. """ - frictions = gdf.rename( - columns={"crsdef_frictionids": "frictionids", "crsdef_frictionid": "frictionid"} - ) - frictions = frictions.drop_duplicates(subset=["frictionid", "frictionids"]).dropna( - how="all" - ) + # Do not support segmented frictions + if "crsdef_frictionids" in gdf.columns: + _do_not_support = ( + gdf["crsdef_frictionids"].str.split(";").apply(np.count_nonzero) > 1 + ) + gdf = gdf.loc[~_do_not_support] + gdf["crsdef_frictionid"] = gdf["crsdef_frictionid"].fillna( + gdf["crsdef_frictionids"] + ) + + frictions = gdf.copy() + frictions = frictions.rename(columns={"crsdef_frictionid": "frictionid"})[ + ["frictionid", "frictionvalue", "frictiontype"] + ] + frictions = frictions.drop_duplicates().dropna(how="all") + friction_fns = [] # create a new friction for i, row in frictions.iterrows(): if isinstance(row.frictionvalue, float) and not np.isnan(row.frictionvalue): fric_model = FrictionModel(global_=row.to_dict()) - fric_name = ( - f"{row.frictiontype[0]}-{str(row.frictionvalue).replace('.', 'p')}" - ) + fric_name = f"{row.frictionid}" fric_filename = f"{fric_model._filename()}_{fric_name}" + fric_model._ext() fric_model.filepath = join(savedir, fric_filename) fric_model.save(fric_model.filepath, recurse=False) From 3b6c8a638449a476c8075b3ebc05d3afb2114f89 Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Thu, 5 Oct 2023 09:45:47 +0200 Subject: [PATCH 15/32] support reading empty structures file --- hydromt_delft3dfm/utils.py | 18 ++++++++++-------- 1 file changed, 10 insertions(+), 8 deletions(-) diff --git a/hydromt_delft3dfm/utils.py b/hydromt_delft3dfm/utils.py index 011e0802..a2e56c7d 100644 --- a/hydromt_delft3dfm/utils.py +++ b/hydromt_delft3dfm/utils.py @@ -442,15 +442,17 @@ def read_structures(branches: gpd.GeoDataFrame, fm_model: FMModel) -> gpd.GeoDat structures_dict[st.id] = st.__dict__ df_structures = pd.DataFrame.from_dict(structures_dict, orient="index") - # Drop comments - df_structures = df_structures.drop( - ["comments"], - axis=1, - ) - - # Add geometry - gdf_structures = helper.get_gdf_from_branches(branches, df_structures) + if len(df_structures) > 0: + # Drop comments + df_structures = df_structures.drop( + ["comments"], + axis=1, + ) + # Add geometry + gdf_structures = helper.get_gdf_from_branches(branches, df_structures) + else: + df_structures = None return gdf_structures From 0c824047521e80ccf83a3c7ed422cfec827949f1 Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Fri, 6 Oct 2023 13:04:17 +0200 Subject: [PATCH 16/32] bug fixing forcing --- hydromt_delft3dfm/utils.py | 30 ++++++++++++++++++++++++++++-- 1 file changed, 28 insertions(+), 2 deletions(-) diff --git a/hydromt_delft3dfm/utils.py b/hydromt_delft3dfm/utils.py index a2e56c7d..1aef32ba 100644 --- a/hydromt_delft3dfm/utils.py +++ b/hydromt_delft3dfm/utils.py @@ -672,10 +672,34 @@ def write_1dboundary(forcing: Dict, savedir: str = None, ext_fn: str = None) -> ext_fn: str or Path, optional Path of the external forcing file (.ext) in which this function will append to. """ + + # remove duplicated name and keep the last + def _remove_old_forcing_based_on_name(forcing): + data_names = [k for k, v in forcing.items()] + data = [v for k, v in forcing.items()] + seen_names = set() + filtered_datanames = [] + filtered_data = [] + # Reverse the list + data_names = data_names[::-1] + data = data[::-1] + for d_name, d in zip(data_names, data): + if d["index"].values[0] not in seen_names: + seen_names.add(d["index"].values[0]) + filtered_data.append(d) + filtered_datanames.append(d_name) + + # Reverse the filtered list + filtered_data = filtered_data[::-1] + filtered_datanames = filtered_datanames[::-1] + return {k: v for k, v in zip(filtered_datanames, filtered_data)} + # filter for 1d boundary forcing = { key: forcing[key] for key in forcing.keys() if key.startswith("boundary1d") } + forcing = _remove_old_forcing_based_on_name(forcing) + if len(forcing) == 0: return @@ -694,14 +718,16 @@ def write_1dboundary(forcing: Dict, savedir: str = None, ext_fn: str = None) -> bc["name"] = i if bc["function"] == "constant": # one quantityunitpair - bc["quantityunitpair"] = [{"quantity": da.name, "unit": bc["units"]}] + bc["quantityunitpair"] = [ + {"quantity": bc["quantity"], "unit": bc["units"]} + ] # only one value column (no times) bc["datablock"] = [[da.sel(index=i).values.item()]] else: # two quantityunitpair bc["quantityunitpair"] = [ {"quantity": "time", "unit": bc["time_unit"]}, - {"quantity": da.name, "unit": bc["units"]}, + {"quantity": bc["quantity"], "unit": bc["units"]}, ] bc.pop("time_unit") # time/value datablock From 6769ca16fa2f10a55d55ed0ea38d71be3b7ee969 Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Fri, 20 Oct 2023 15:36:25 +0200 Subject: [PATCH 17/32] remove temporary property on read/write mode --- hydromt_delft3dfm/dflowfm.py | 34 +++++++++++----------------------- 1 file changed, 11 insertions(+), 23 deletions(-) diff --git a/hydromt_delft3dfm/dflowfm.py b/hydromt_delft3dfm/dflowfm.py index e9bc75bb..f1247399 100644 --- a/hydromt_delft3dfm/dflowfm.py +++ b/hydromt_delft3dfm/dflowfm.py @@ -2923,18 +2923,6 @@ def setup_rainfall_from_uniform_timeseries( self.set_config("external_forcing.rainfall", 1) # ## I/O - # TODO: remove after hydromt 0.6.1 release - @property - def _assert_write_mode(self): - if not self._write: - raise IOError("Model opened in read-only mode") - - # TODO: remove after hydromt 0.6.1 release - @property - def _assert_read_mode(self): - if not self._read: - raise IOError("Model opened in write-only mode") - def read(self): """Method to read the complete model schematization and configuration from file. # FIXME: where to read crs?. @@ -2998,7 +2986,7 @@ def write_config(self) -> None: """From config dict to Hydrolib MDU.""" # Not sure if this is worth it compared to just calling write_config super method # advantage is the validator but the whole model is then read when initialising FMModel - self._assert_write_mode + self._assert_write_mode() cf_dict = self._config.copy() # Need to switch to dflowfm folder for files to be found and properly added @@ -3016,7 +3004,7 @@ def write_config(self) -> None: def read_maps(self) -> Dict[str, Union[xr.Dataset, xr.DataArray]]: """Read maps from initialfield and parse to dict of xr.DataArray.""" - self._assert_read_mode + self._assert_read_mode() # Read initial fields inifield_model = self.dfmmodel.geometry.inifieldfile # seperate 1d and 2d @@ -3079,7 +3067,7 @@ def write_maps(self) -> None: if len(self._maps) == 0: self.logger.debug("No maps data found, skip writing.") return - self._assert_write_mode + self._assert_write_mode() # Global parameters mapsroot = join(self.root, "maps") inilist = [] @@ -3177,7 +3165,7 @@ def read_geoms(self) -> None: # FIXME: gives an error when only 2D model. For branches / boundaries etc... the reading of hydrolib-core objects happens in read_mesh There the geoms geojson copies are re-set based on dflowfm files content. """ - self._assert_read_mode + self._assert_read_mode() super().read_geoms(fn="geoms/region.geojson") if self.dfmmodel.geometry.crosslocfile is not None: @@ -3210,7 +3198,7 @@ def read_geoms(self) -> None: # FIXME: gives an error when only 2D model. def write_geoms(self, write_mesh_gdf=True) -> None: """Write model geometries to a GeoJSON file at /.""" - self._assert_write_mode + self._assert_write_mode() # Write dfm files savedir = dirname(join(self.root, self._config_fn)) @@ -3281,7 +3269,7 @@ def read_forcing( self, ) -> None: # FIXME reading of forcing should include boundary, lateral and meteo """Read forcing at and parse to dict of xr.DataArray.""" - self._assert_read_mode + self._assert_read_mode() # Read external forcing ext_model = self.dfmmodel.external_forcing.extforcefilenew if ext_model is not None: @@ -3345,7 +3333,7 @@ def write_forcing(self) -> None: if len(self._forcing) == 0: self.logger.debug("No forcing data found, skip writing.") else: - self._assert_write_mode + self._assert_write_mode() self.logger.info("Writting forcing files.") savedir = dirname(join(self.root, self._config_fn)) # create new external forcing file @@ -3360,7 +3348,7 @@ def write_forcing(self) -> None: def read_mesh(self): """Read network file with Hydrolib-core and extract mesh/branches info.""" - self._assert_read_mode + self._assert_read_mode() # Read mesh # hydrolib-core convention @@ -3402,7 +3390,7 @@ def read_mesh(self): def write_mesh(self, write_gui=True): """Write 1D branches and 2D mesh at in model ready format.""" - self._assert_write_mode + self._assert_write_mode() savedir = dirname(join(self.root, self._config_fn)) mesh_filename = "fm_net.nc" @@ -3496,7 +3484,7 @@ def init_dfmmodel(self): self.logger.info(f"Reading mdu file at {mdu_fn}") self._dfmmodel = FMModel(filepath=mdu_fn) else: # use hydrolib template - self._assert_write_mode + self._assert_write_mode() self.logger.info("Initialising empty mdu file") self._dfmmodel = FMModel() self._dfmmodel.filepath = mdu_fn @@ -3518,7 +3506,7 @@ def read_dimr(self, dimr_fn: Optional[str] = None) -> None: dimr = DIMR(filepath=Path(dimr_fn)) # else initialise else: - self._assert_write_mode + self._assert_write_mode() self.logger.info("Initialising empty dimr file") dimr = DIMR() self._dimr = dimr From ce950afbacf7952918ea0e58dd11e440ba441428 Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Mon, 23 Oct 2023 17:07:18 +0200 Subject: [PATCH 18/32] fix syntax error --- hydromt_delft3dfm/dflowfm.py | 1 - 1 file changed, 1 deletion(-) diff --git a/hydromt_delft3dfm/dflowfm.py b/hydromt_delft3dfm/dflowfm.py index dfe04a59..d112b6f0 100644 --- a/hydromt_delft3dfm/dflowfm.py +++ b/hydromt_delft3dfm/dflowfm.py @@ -191,7 +191,6 @@ def __init__( self._crs = CRS.from_user_input(crs) if crs else None self._check_crs() - def setup_region(self, region): def setup_region(self, region): """HYDROMT CORE METHOD NOT USED FOR DFlowFMModel.""" raise ValueError( From ae7eeac92e1945de1079fcd6eb52c474f2446279 Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Tue, 24 Oct 2023 10:17:08 +0200 Subject: [PATCH 19/32] temp fix for geodataset crs --- hydromt_delft3dfm/workflows/boundaries.py | 3 +++ 1 file changed, 3 insertions(+) diff --git a/hydromt_delft3dfm/workflows/boundaries.py b/hydromt_delft3dfm/workflows/boundaries.py index d19840c3..3d685d37 100644 --- a/hydromt_delft3dfm/workflows/boundaries.py +++ b/hydromt_delft3dfm/workflows/boundaries.py @@ -267,6 +267,9 @@ def compute_boundary_values( # snap user boundary to potential boundary locations to get nodeid gdf_bnd = da_bnd.vector.to_gdf() + gdf_bnd.crs = ( + boundaries.crs + ) # FIXME temp fix for hydromt reprojection issue #613 gdf_bnd = hydromt.gis_utils.nearest_merge( gdf_bnd, boundaries, From 7656a331bb7c8251eab413c33703964224cdef16 Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Tue, 24 Oct 2023 10:21:38 +0200 Subject: [PATCH 20/32] update examples for tests (differences verified) --- examples/dflowfm_local/dflowfm/bnd.ext | 9 - .../boundaryconditions1d_waterlevelbnd.bc | 78 - examples/dflowfm_local/dflowfm/fm_net.nc | Bin 152476 -> 152476 bytes .../dflowfm/lateral1d_discharge.bc | 78 - .../dflowfm/roughness_M-0p023.ini | 11 - .../dflowfm/roughness_W-0p003.ini | 11 - examples/dflowfm_local/dimr_config.xml | 2 +- .../dflowfm_local/geoms/boundaries.geojson | 24 +- examples/dflowfm_local/geoms/branches.geojson | 56 +- examples/dflowfm_local/geoms/bridges.geojson | 9 +- examples/dflowfm_local/geoms/culverts.geojson | 6 +- .../dflowfm_local/geoms/pipe_nodes.geojson | 40 +- examples/dflowfm_local/geoms/pipes.geojson | 28 +- examples/dflowfm_local/geoms/rivers.geojson | 28 +- .../dflowfm_local/geoms/rivers_nodes.geojson | 34 +- examples/dflowfm_piave/dflowfm/bnd.ext | 21 +- .../boundaryconditions1d_waterlevelbnd.bc | 42 - examples/dflowfm_piave/dflowfm/fm_net.nc | Bin 887400 -> 858588 bytes .../dflowfm/roughness_M-0p023.ini | 11 - .../dflowfm/roughness_W-0p003.ini | 11 - examples/dflowfm_piave/dimr_config.xml | 6 +- .../dflowfm_piave/geoms/boundaries.geojson | 99 +- examples/dflowfm_piave/geoms/branches.geojson | 3024 ++++++----------- examples/dflowfm_piave/geoms/manholes.geojson | 2014 +++++------ examples/dflowfm_piave/geoms/pipes.geojson | 3006 ++++++---------- examples/dflowfm_piave/geoms/rivers.geojson | 21 +- .../dflowfm_piave/geoms/rivers_nodes.geojson | 21 +- 27 files changed, 3172 insertions(+), 5518 deletions(-) delete mode 100644 examples/dflowfm_local/dflowfm/boundaryconditions1d_waterlevelbnd.bc delete mode 100644 examples/dflowfm_local/dflowfm/lateral1d_discharge.bc delete mode 100644 examples/dflowfm_local/dflowfm/roughness_M-0p023.ini delete mode 100644 examples/dflowfm_local/dflowfm/roughness_W-0p003.ini delete mode 100644 examples/dflowfm_piave/dflowfm/boundaryconditions1d_waterlevelbnd.bc delete mode 100644 examples/dflowfm_piave/dflowfm/roughness_M-0p023.ini delete mode 100644 examples/dflowfm_piave/dflowfm/roughness_W-0p003.ini diff --git a/examples/dflowfm_local/dflowfm/bnd.ext b/examples/dflowfm_local/dflowfm/bnd.ext index 8f5b0a6f..0eb6705c 100644 --- a/examples/dflowfm_local/dflowfm/bnd.ext +++ b/examples/dflowfm_local/dflowfm/bnd.ext @@ -12,21 +12,12 @@ forcingFile = boundarycondition1d.bc [Boundary] quantity = waterlevelbnd nodeId = 666180.040000_1525894.770000 -<<<<<<< HEAD forcingFile = boundarycondition1d.bc -======= -forcingFile = boundaryconditions1d_waterlevelbnd.bc [Boundary] quantity = waterlevelbnd locationFile = 0.pli forcingFile = boundaryconditions2d_0.bc ->>>>>>> main - -[Boundary] -quantity = waterlevelbnd -locationFile = 1.pli -forcingFile = boundaryconditions2d_1.bc [Boundary] quantity = waterlevelbnd diff --git a/examples/dflowfm_local/dflowfm/boundaryconditions1d_waterlevelbnd.bc b/examples/dflowfm_local/dflowfm/boundaryconditions1d_waterlevelbnd.bc deleted file mode 100644 index e8d29391..00000000 --- a/examples/dflowfm_local/dflowfm/boundaryconditions1d_waterlevelbnd.bc +++ /dev/null @@ -1,78 +0,0 @@ -# written by HYDROLIB-core 0.5.2 - -[General] -fileVersion = 1.01 -fileType = boundConds - -[Forcing] -name = 664197.234160_1527152.705985 -function = timeseries -timeInterpolation = linear -offset = 0.0 -factor = 1.0 -quantity = time -unit = hours since 2020-01-01 00:00:00 -quantity = waterlevelbnd -unit = m -0.0 -1.0 -1.0 -1.0 -2.0 -1.0 -3.0 -1.0 -4.0 -1.0 -5.0 -1.0 -6.0 -1.0 -7.0 -1.0 -8.0 -1.0 -9.0 -1.0 -10.0 -1.0 -11.0 -1.0 -12.0 -1.0 -13.0 -1.0 -14.0 -1.0 -15.0 -1.0 -16.0 -1.0 -17.0 -1.0 -18.0 -1.0 -19.0 -1.0 -20.0 -1.0 -21.0 -1.0 -22.0 -1.0 -23.0 -1.0 -24.0 -1.0 - -[Forcing] -name = 666180.040000_1525894.770000 -function = timeseries -timeInterpolation = linear -offset = 0.0 -factor = 1.0 -quantity = time -unit = hours since 2020-01-01 00:00:00 -quantity = waterlevelbnd -unit = m -0.0 0.0 -1.0 0.0 -2.0 0.0 -3.0 0.0 -4.0 0.0 -5.0 0.0 -6.0 0.0 -7.0 0.0 -8.0 0.0 -9.0 0.0 -10.0 0.0 -11.0 0.0 -12.0 0.0 -13.0 0.0 -14.0 0.0 -15.0 0.0 -16.0 0.0 -17.0 0.0 -18.0 0.0 -19.0 0.0 -20.0 0.0 -21.0 0.0 -22.0 0.0 -23.0 0.0 -24.0 0.0 - diff --git a/examples/dflowfm_local/dflowfm/fm_net.nc b/examples/dflowfm_local/dflowfm/fm_net.nc index 87c04e857d6e166ce321a3e4fa5384a212898453..aae1b5fc02466d38a1f6b57028223c8168b3432c 100644 GIT binary patch delta 37 scmbQUoO8}{&J7Aoe1- 1.3 hydrolib-core 0.5.2 - 2023-10-12T13:19:57.474727 + 2023-10-24T08:17:19.050552 diff --git a/examples/dflowfm_local/geoms/boundaries.geojson b/examples/dflowfm_local/geoms/boundaries.geojson index 76a3b7a9..cb8131ed 100644 --- a/examples/dflowfm_local/geoms/boundaries.geojson +++ b/examples/dflowfm_local/geoms/boundaries.geojson @@ -2,17 +2,17 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -{ "type": "Feature", "properties": { "level_0": 662793.79418679164, "level_1": 1524515.4517321615, "branchtype": "river", "branchid": "river_1", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "river_1", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": 1, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "where": "downstream", "distance_right": 2.6354886210617495e-07, "nodeid": "662793.794187_1524515.451732" }, "geometry": { "type": "Point", "coordinates": [ 662793.794186791637912, 1524515.451732161454856 ] } }, -{ "type": "Feature", "properties": { "level_0": 664197.23415962339, "level_1": 1527152.7059848213, "branchtype": "river", "branchid": "river_2", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "river_2", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": 2, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "where": "downstream", "distance_right": 4.1679906021887385e-07, "nodeid": "664197.234160_1527152.705985" }, "geometry": { "type": "Point", "coordinates": [ 664197.234159623389132, 1527152.705984821310267 ] } }, -{ "type": "Feature", "properties": { "level_0": 666180.04, "level_1": 1525894.77, "branchtype": "river", "branchid": "branch_8", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_8", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": 10, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "where": "upstream", "distance_right": 6.9849193096160889e-10, "nodeid": "666180.040000_1525894.770000" }, "geometry": { "type": "Point", "coordinates": [ 666180.040000000037253, 1525894.769999999320135 ] } }, -{ "type": "Feature", "properties": { "level_0": 664789.14617260336, "level_1": 1525073.3461271923, "branchtype": "river", "branchid": "branch_11", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_11", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": 12, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "where": "upstream", "distance_right": 4.4079386833570057e-07, "nodeid": "664789.146173_1525073.346127" }, "geometry": { "type": "Point", "coordinates": [ 664789.146172603359446, 1525073.346127192256972 ] } }, -{ "type": "Feature", "properties": { "level_0": 664190.38579999981, "level_1": 1525924.0326000003, "branchtype": "pipe", "branchid": "pipe_5", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_5", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 16, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 3.2927225399135965e-10, "nodeid": "664190.385800_1525924.032600" }, "geometry": { "type": "Point", "coordinates": [ 664190.385799999814481, 1525924.032600000267848 ] } }, -{ "type": "Feature", "properties": { "level_0": 664048.32531966059, "level_1": 1525098.0711124309, "branchtype": "pipe", "branchid": "pipe_9", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 20, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 5.4853769327396927e-07, "nodeid": "664048.325320_1525098.071112" }, "geometry": { "type": "Point", "coordinates": [ 664048.325319660594687, 1525098.071112430887297 ] } }, -{ "type": "Feature", "properties": { "level_0": 664702.72692603013, "level_1": 1525750.0985501537, "branchtype": "pipe", "branchid": "pipe_10", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 21, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 1.5659834095829541e-07, "nodeid": "664702.726926_1525750.098550" }, "geometry": { "type": "Point", "coordinates": [ 664702.726926030125469, 1525750.098550153663382 ] } }, -{ "type": "Feature", "properties": { "level_0": 664747.43349663052, "level_1": 1525729.6497995616, "branchtype": "pipe", "branchid": "pipe_12", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 23, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 5.7336208882836857e-07, "nodeid": "664747.433497_1525729.649800" }, "geometry": { "type": "Point", "coordinates": [ 664747.433496630517766, 1525729.649799561593682 ] } }, -{ "type": "Feature", "properties": { "level_0": 665219.64311349345, "level_1": 1525514.959856804, "branchtype": "pipe", "branchid": "pipe_14", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_14", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 25, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 5.3099907323260637e-07, "nodeid": "665219.643113_1525514.959857" }, "geometry": { "type": "Point", "coordinates": [ 665219.643113493453711, 1525514.959856803994626 ] } }, -{ "type": "Feature", "properties": { "level_0": 664708.73862075247, "level_1": 1524483.1447981687, "branchtype": "pipe", "branchid": "pipe_15", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_15", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 26, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 2.9945179934390397e-07, "nodeid": "664708.738621_1524483.144798" }, "geometry": { "type": "Point", "coordinates": [ 664708.738620752468705, 1524483.144798168679699 ] } }, -{ "type": "Feature", "properties": { "level_0": 665277.57411764679, "level_1": 1525446.3931947846, "branchtype": "pipe", "branchid": "pipe_16", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_16", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 27, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 4.136866578190493e-07, "nodeid": "665277.574118_1525446.393195" }, "geometry": { "type": "Point", "coordinates": [ 665277.574117646785453, 1525446.393194784643129 ] } }, -{ "type": "Feature", "properties": { "level_0": 665292.61532070651, "level_1": 1525470.8495163794, "branchtype": "pipe", "branchid": "pipe_17", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_17", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 28, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 4.7975319107342047e-07, "nodeid": "665292.615321_1525470.849516" }, "geometry": { "type": "Point", "coordinates": [ 665292.615320706507191, 1525470.849516379414126 ] } } +{ "type": "Feature", "properties": { "level_0": 662793.79418679164, "level_1": 1524515.4517321615, "branchid": "river_1", "branchtype": "river", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "river_1", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": 1, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "where": "downstream", "distance_right": 2.6354886210617495e-07, "nodeid": "662793.794187_1524515.451732" }, "geometry": { "type": "Point", "coordinates": [ 662793.794186791637912, 1524515.451732161454856 ] } }, +{ "type": "Feature", "properties": { "level_0": 664197.23415962339, "level_1": 1527152.7059848213, "branchid": "river_2", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "river_2", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": 2, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "where": "downstream", "distance_right": 4.1679906021887385e-07, "nodeid": "664197.234160_1527152.705985" }, "geometry": { "type": "Point", "coordinates": [ 664197.234159623389132, 1527152.705984821310267 ] } }, +{ "type": "Feature", "properties": { "level_0": 666180.04, "level_1": 1525894.77, "branchid": "branch_8", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_8", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": 10, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "where": "upstream", "distance_right": 6.9849193096160889e-10, "nodeid": "666180.040000_1525894.770000" }, "geometry": { "type": "Point", "coordinates": [ 666180.040000000037253, 1525894.769999999320135 ] } }, +{ "type": "Feature", "properties": { "level_0": 664789.14617260336, "level_1": 1525073.3461271923, "branchid": "branch_11", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_11", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": 12, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "where": "upstream", "distance_right": 4.4079386833570057e-07, "nodeid": "664789.146173_1525073.346127" }, "geometry": { "type": "Point", "coordinates": [ 664789.146172603359446, 1525073.346127192256972 ] } }, +{ "type": "Feature", "properties": { "level_0": 664190.38579999981, "level_1": 1525924.0326000003, "branchid": "pipe_5", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_5", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 16, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 3.2927225399135965e-10, "nodeid": "664190.385800_1525924.032600" }, "geometry": { "type": "Point", "coordinates": [ 664190.385799999814481, 1525924.032600000267848 ] } }, +{ "type": "Feature", "properties": { "level_0": 664048.32531966059, "level_1": 1525098.0711124309, "branchid": "pipe_9", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 20, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 5.4853769327396927e-07, "nodeid": "664048.325320_1525098.071112" }, "geometry": { "type": "Point", "coordinates": [ 664048.325319660594687, 1525098.071112430887297 ] } }, +{ "type": "Feature", "properties": { "level_0": 664702.72692603013, "level_1": 1525750.0985501537, "branchid": "pipe_10", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 21, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 1.5659834095829541e-07, "nodeid": "664702.726926_1525750.098550" }, "geometry": { "type": "Point", "coordinates": [ 664702.726926030125469, 1525750.098550153663382 ] } }, +{ "type": "Feature", "properties": { "level_0": 664747.43349663052, "level_1": 1525729.6497995616, "branchid": "pipe_12", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 23, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 5.7336208882836857e-07, "nodeid": "664747.433497_1525729.649800" }, "geometry": { "type": "Point", "coordinates": [ 664747.433496630517766, 1525729.649799561593682 ] } }, +{ "type": "Feature", "properties": { "level_0": 665219.64311349345, "level_1": 1525514.959856804, "branchid": "pipe_14", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_14", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 25, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 5.3099907323260637e-07, "nodeid": "665219.643113_1525514.959857" }, "geometry": { "type": "Point", "coordinates": [ 665219.643113493453711, 1525514.959856803994626 ] } }, +{ "type": "Feature", "properties": { "level_0": 664708.73862075247, "level_1": 1524483.1447981687, "branchid": "pipe_15", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_15", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 26, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 2.9945179934390397e-07, "nodeid": "664708.738621_1524483.144798" }, "geometry": { "type": "Point", "coordinates": [ 664708.738620752468705, 1524483.144798168679699 ] } }, +{ "type": "Feature", "properties": { "level_0": 665277.57411764679, "level_1": 1525446.3931947846, "branchid": "pipe_16", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_16", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 27, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 4.136866578190493e-07, "nodeid": "665277.574118_1525446.393195" }, "geometry": { "type": "Point", "coordinates": [ 665277.574117646785453, 1525446.393194784643129 ] } }, +{ "type": "Feature", "properties": { "level_0": 665292.61532070651, "level_1": 1525470.8495163794, "branchid": "pipe_17", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_17", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 28, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "where": "upstream", "distance_right": 4.7975319107342047e-07, "nodeid": "665292.615321_1525470.849516" }, "geometry": { "type": "Point", "coordinates": [ 665292.615320706507191, 1525470.849516379414126 ] } } ] } diff --git a/examples/dflowfm_local/geoms/branches.geojson b/examples/dflowfm_local/geoms/branches.geojson index ab1e962e..5d910637 100644 --- a/examples/dflowfm_local/geoms/branches.geojson +++ b/examples/dflowfm_local/geoms/branches.geojson @@ -2,33 +2,33 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_4", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_4", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_0_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664438.813829420600086, 1525829.800284768920392 ], [ 664429.038999999989755, 1526107.098 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_5", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_5", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_1_generated", "manhole_dn": "manhole_0_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664190.385799999814481, 1525924.032600000267848 ], [ 664438.813829420600086, 1525829.800284768920392 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_6", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_2_generated", "manhole_dn": "manhole_0_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664217.490140905487351, 1525583.23970616585575 ], [ 664438.813829420600086, 1525829.800284768920392 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_7", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_3_generated", "manhole_dn": "manhole_2_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 663936.864700614358298, 1525261.152571672573686 ], [ 664217.490140905487351, 1525583.23970616585575 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_8", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_4_generated", "manhole_dn": "manhole_3_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 663871.550461587961763, 1525175.738024139311165 ], [ 663897.086400000494905, 1525212.559499999275431 ], [ 663936.864700614358298, 1525261.152571672573686 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_9", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_5_generated", "manhole_dn": "manhole_4_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664048.325319660594687, 1525098.071112430887297 ], [ 663871.550461587961763, 1525175.738024139311165 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_10", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_6_generated", "manhole_dn": "manhole_7_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664702.726926030125469, 1525750.098550153663382 ], [ 664481.894200000097044, 1525830.303300000727177 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_11", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_7_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664481.894200000097044, 1525830.303300000727177 ], [ 664474.13, 1526115.7 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_12", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_8_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664747.433496630517766, 1525729.649799561593682 ], [ 664838.810497992672026, 1525698.612855288665742 ], [ 664907.926478271954693, 1525663.288345249835402 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_13", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_13", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_9_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664849.475700000301003, 1525031.354499999433756 ], [ 665115.699999999953434, 1524944.79 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_14", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_14", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_10_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665219.643113493453711, 1525514.959856803994626 ], [ 665030.18360000057146, 1525603.506899999454618 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_15", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_15", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_11_generated", "manhole_dn": "manhole_9_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664708.738620752468705, 1524483.144798168679699 ], [ 664849.475700000301003, 1525031.354499999433756 ], [ 664849.475700000301003, 1525031.354499999433756 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_16", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_16", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_12_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665277.574117646785453, 1525446.393194784643129 ], [ 665356.868200000026263, 1525406.9835 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_17", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_17", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_13_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665292.615320706507191, 1525470.849516379414126 ], [ 665369.906399999978021, 1525431.4412 ], [ 665369.906399999978021, 1525431.4412 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "river_1", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "river_1", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664057.966296999948099, 1526147.834882 ], [ 663918.391924358904362, 1525803.10090322420001 ], [ 663700.482064640615135, 1525466.331120023271069 ], [ 663353.045365229598247, 1525088.417517154943198 ], [ 662879.129516471526586, 1524643.454726681346074 ], [ 662793.794186791637912, 1524515.451732161454856 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "river_2", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "river_2", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664057.966296999948099, 1526147.834882 ], [ 664218.310854589915834, 1526625.788610660471022 ], [ 664218.310854589915834, 1527005.169120056321844 ], [ 664197.234159623389132, 1527152.705984821310267 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_1", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_1", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665115.699999999953434, 1524944.79 ], [ 665356.868200000026263, 1525406.9835 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_2", "branchorder": 2.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_2", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665356.868200000026263, 1525406.9835 ], [ 665369.906399999978021, 1525431.441199999069795 ], [ 665369.906399999978021, 1525431.4412 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_3", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_3", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665369.906399999978021, 1525431.4412 ], [ 665641.789999999804422, 1525937.96000000089407 ], [ 665641.789999999804422, 1525937.96000000089407 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_4", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_4", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665641.789999999804422, 1525937.96000000089407 ], [ 665560.620547444559634, 1525952.124135404126719 ], [ 665480.575254552299157, 1525953.687039414886385 ], [ 665416.820000000414439, 1525962.189999999245629 ], [ 665346.659376955241896, 1525982.895817694021389 ], [ 665271.309999999706633, 1526001.859999999403954 ], [ 665243.630000000470318, 1526003.289999998640269 ], [ 665243.630000000470318, 1526003.289999997941777 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_5", "branchorder": 3.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_5", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665243.630000000470318, 1526003.289999997941777 ], [ 665116.950000000419095, 1525983.029999999096617 ], [ 665051.90000000083819, 1525977.32 ], [ 664963.504724813159555, 1526014.666760261869058 ], [ 664918.370000000344589, 1526039.810000000521541 ], [ 664826.210000000428408, 1526041.519999999552965 ], [ 664752.459499345044605, 1526065.157490010838956 ], [ 664672.28994727297686, 1526086.417805780190974 ], [ 664642.852168873418123, 1526095.560649296734482 ], [ 664550.869999999529682, 1526115.410000000149012 ], [ 664474.13, 1526115.7 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_6", "branchorder": 4.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_6", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664474.13, 1526115.7 ], [ 664429.038999999989755, 1526107.098 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_7", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_7", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664429.038999999989755, 1526107.098 ], [ 664272.40999999945052, 1526129.970000000204891 ], [ 664169.979999999864958, 1526140.529999999562278 ], [ 664092.240000000223517, 1526143.2899999988731 ], [ 664057.966296999948099, 1526147.834882 ], [ 664057.966296999948099, 1526147.834882 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_8", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_8", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 666180.040000000037253, 1525894.769999999320135 ], [ 665891.336423385655507, 1526041.311705864733085 ], [ 665733.269999999320135, 1526117.310000000521541 ], [ 665733.269999999320135, 1526117.310000000521541 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_10", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_10", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665733.269999999320135, 1526117.310000000521541 ], [ 665641.789999999804422, 1525937.96000000089407 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_11", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_11", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664789.146172603359446, 1525073.346127192256972 ], [ 665015.157200000365265, 1525576.51439999951981 ], [ 665015.157200000365265, 1525576.514399999286979 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_12", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_12", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665015.157200000365265, 1525576.514399999286979 ], [ 665030.18360000057146, 1525603.506899999454618 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_13", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_13", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665030.18360000057146, 1525603.506899999454618 ], [ 665243.630000000470318, 1526003.289999997941777 ] ] } } +{ "type": "Feature", "properties": { "branchid": "pipe_4", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_4", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_0_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664438.813829420600086, 1525829.800284768920392 ], [ 664429.038999999989755, 1526107.098 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_5", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_5", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_1_generated", "manhole_dn": "manhole_0_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664190.385799999814481, 1525924.032600000267848 ], [ 664438.813829420600086, 1525829.800284768920392 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_6", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_2_generated", "manhole_dn": "manhole_0_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664217.490140905487351, 1525583.23970616585575 ], [ 664438.813829420600086, 1525829.800284768920392 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_7", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_3_generated", "manhole_dn": "manhole_2_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 663936.864700614358298, 1525261.152571672573686 ], [ 664217.490140905487351, 1525583.23970616585575 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_8", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_4_generated", "manhole_dn": "manhole_3_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 663871.550461587961763, 1525175.738024139311165 ], [ 663897.086400000494905, 1525212.559499999275431 ], [ 663936.864700614358298, 1525261.152571672573686 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_9", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_5_generated", "manhole_dn": "manhole_4_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664048.325319660594687, 1525098.071112430887297 ], [ 663871.550461587961763, 1525175.738024139311165 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_10", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_6_generated", "manhole_dn": "manhole_7_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664702.726926030125469, 1525750.098550153663382 ], [ 664481.894200000097044, 1525830.303300000727177 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_11", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_7_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664481.894200000097044, 1525830.303300000727177 ], [ 664474.13, 1526115.7 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_12", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_8_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664747.433496630517766, 1525729.649799561593682 ], [ 664838.810497992672026, 1525698.612855288665742 ], [ 664907.926478271954693, 1525663.288345249835402 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_13", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_13", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_9_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664849.475700000301003, 1525031.354499999433756 ], [ 665115.699999999953434, 1524944.79 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_14", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_14", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_10_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665219.643113493453711, 1525514.959856803994626 ], [ 665030.18360000057146, 1525603.506899999454618 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_15", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_15", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_11_generated", "manhole_dn": "manhole_9_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664708.738620752468705, 1524483.144798168679699 ], [ 664849.475700000301003, 1525031.354499999433756 ], [ 664849.475700000301003, 1525031.354499999433756 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_16", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_16", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_12_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665277.574117646785453, 1525446.393194784643129 ], [ 665356.868200000026263, 1525406.9835 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_17", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_17", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_13_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665292.615320706507191, 1525470.849516379414126 ], [ 665369.906399999978021, 1525431.4412 ], [ 665369.906399999978021, 1525431.4412 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "river_1", "branchtype": "river", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "river_1", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664057.966296999948099, 1526147.834882 ], [ 663918.391924358904362, 1525803.10090322420001 ], [ 663700.482064640615135, 1525466.331120023271069 ], [ 663353.045365229598247, 1525088.417517154943198 ], [ 662879.129516471526586, 1524643.454726681346074 ], [ 662793.794186791637912, 1524515.451732161454856 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "river_2", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "river_2", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664057.966296999948099, 1526147.834882 ], [ 664218.310854589915834, 1526625.788610660471022 ], [ 664218.310854589915834, 1527005.169120056321844 ], [ 664197.234159623389132, 1527152.705984821310267 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_1", "branchtype": "river", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_1", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665115.699999999953434, 1524944.79 ], [ 665356.868200000026263, 1525406.9835 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_2", "branchtype": "river", "branchorder": 2.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_2", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665356.868200000026263, 1525406.9835 ], [ 665369.906399999978021, 1525431.441199999069795 ], [ 665369.906399999978021, 1525431.4412 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_3", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_3", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665369.906399999978021, 1525431.4412 ], [ 665641.789999999804422, 1525937.96000000089407 ], [ 665641.789999999804422, 1525937.96000000089407 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_4", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_4", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665641.789999999804422, 1525937.96000000089407 ], [ 665560.620547444559634, 1525952.124135404126719 ], [ 665480.575254552299157, 1525953.687039414886385 ], [ 665416.820000000414439, 1525962.189999999245629 ], [ 665346.659376955241896, 1525982.895817694021389 ], [ 665271.309999999706633, 1526001.859999999403954 ], [ 665243.630000000470318, 1526003.289999998640269 ], [ 665243.630000000470318, 1526003.289999997941777 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_5", "branchtype": "river", "branchorder": 3.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_5", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665243.630000000470318, 1526003.289999997941777 ], [ 665116.950000000419095, 1525983.029999999096617 ], [ 665051.90000000083819, 1525977.32 ], [ 664963.504724813159555, 1526014.666760261869058 ], [ 664918.370000000344589, 1526039.810000000521541 ], [ 664826.210000000428408, 1526041.519999999552965 ], [ 664752.459499345044605, 1526065.157490010838956 ], [ 664672.28994727297686, 1526086.417805780190974 ], [ 664642.852168873418123, 1526095.560649296734482 ], [ 664550.869999999529682, 1526115.410000000149012 ], [ 664474.13, 1526115.7 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_6", "branchtype": "river", "branchorder": 4.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_6", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664474.13, 1526115.7 ], [ 664429.038999999989755, 1526107.098 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_7", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_7", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664429.038999999989755, 1526107.098 ], [ 664272.40999999945052, 1526129.970000000204891 ], [ 664169.979999999864958, 1526140.529999999562278 ], [ 664092.240000000223517, 1526143.2899999988731 ], [ 664057.966296999948099, 1526147.834882 ], [ 664057.966296999948099, 1526147.834882 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_8", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_8", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 666180.040000000037253, 1525894.769999999320135 ], [ 665891.336423385655507, 1526041.311705864733085 ], [ 665733.269999999320135, 1526117.310000000521541 ], [ 665733.269999999320135, 1526117.310000000521541 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_10", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_10", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665733.269999999320135, 1526117.310000000521541 ], [ 665641.789999999804422, 1525937.96000000089407 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_11", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_11", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664789.146172603359446, 1525073.346127192256972 ], [ 665015.157200000365265, 1525576.51439999951981 ], [ 665015.157200000365265, 1525576.514399999286979 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_12", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_12", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665015.157200000365265, 1525576.514399999286979 ], [ 665030.18360000057146, 1525603.506899999454618 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_13", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_13", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665030.18360000057146, 1525603.506899999454618 ], [ 665243.630000000470318, 1526003.289999997941777 ] ] } } ] } diff --git a/examples/dflowfm_local/geoms/bridges.geojson b/examples/dflowfm_local/geoms/bridges.geojson index 31e80b39..42d0ad36 100644 --- a/examples/dflowfm_local/geoms/bridges.geojson +++ b/examples/dflowfm_local/geoms/bridges.geojson @@ -2,12 +2,7 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -<<<<<<< HEAD -{ "type": "Feature", "properties": { "pillarwidth": null, "branchid": "branch_12", "friction": 0.023, "length": 10.0, "type": "bridge", "frictiontype": "Manning", "formfactor": null, "outletlosscoeff": 0.2, "inletlosscoeff": 0.2, "id": "bridge_1", "shift": 2.34, "chainage": 14.101, "csdefid": "rect_h1.550_w2.000_cno_point", "allowedflowdir": "positive" }, "geometry": { "type": "Point", "coordinates": [ 665021.849053248995915, 1525588.928306785644963 ] } }, -{ "type": "Feature", "properties": { "pillarwidth": null, "branchid": "branch_3", "friction": 0.023, "length": 5.0, "type": "bridge", "frictiontype": "Manning", "formfactor": null, "outletlosscoeff": 0.82, "inletlosscoeff": 0.8, "id": "bridge_2", "shift": 2.37, "chainage": 485.794, "csdefid": "rect_h1.800_w5.000_cyes_point", "allowedflowdir": "both" }, "geometry": { "type": "Point", "coordinates": [ 665599.689329552114941, 1525859.454655284294859 ] } } -======= -{ "type": "Feature", "properties": { "frictiontype": "Manning", "length": 10.0, "shift": 2.34, "branchid": "branch_12", "allowedflowdir": "positive", "friction": 0.023, "type": "bridge", "chainage": 14.101, "formfactor": null, "id": "bridge_1", "outletlosscoeff": 0.2, "pillarwidth": null, "csdefid": "rect_h1.550_w2.000_cno_point", "inletlosscoeff": 0.2 }, "geometry": { "type": "Point", "coordinates": [ 665021.849053248995915, 1525588.928306785644963 ] } }, -{ "type": "Feature", "properties": { "frictiontype": "Manning", "length": 5.0, "shift": 2.37, "branchid": "branch_3", "allowedflowdir": "both", "friction": 0.023, "type": "bridge", "chainage": 485.794, "formfactor": null, "id": "bridge_2", "outletlosscoeff": 0.82, "pillarwidth": null, "csdefid": "rect_h1.800_w5.000_cyes_point", "inletlosscoeff": 0.8 }, "geometry": { "type": "Point", "coordinates": [ 665599.689329552114941, 1525859.454655284294859 ] } } ->>>>>>> main +{ "type": "Feature", "properties": { "friction": 0.023, "frictiontype": "Manning", "csdefid": "rect_h1.550_w2.000_cno_point", "length": 10.0, "inletlosscoeff": 0.2, "id": "bridge_1", "pillarwidth": null, "allowedflowdir": "positive", "formfactor": null, "type": "bridge", "branchid": "branch_12", "shift": 2.34, "outletlosscoeff": 0.2, "chainage": 14.101 }, "geometry": { "type": "Point", "coordinates": [ 665021.849053248995915, 1525588.928306785644963 ] } }, +{ "type": "Feature", "properties": { "friction": 0.023, "frictiontype": "Manning", "csdefid": "rect_h1.800_w5.000_cyes_point", "length": 5.0, "inletlosscoeff": 0.8, "id": "bridge_2", "pillarwidth": null, "allowedflowdir": "both", "formfactor": null, "type": "bridge", "branchid": "branch_3", "shift": 2.37, "outletlosscoeff": 0.82, "chainage": 485.794 }, "geometry": { "type": "Point", "coordinates": [ 665599.689329552114941, 1525859.454655284294859 ] } } ] } diff --git a/examples/dflowfm_local/geoms/culverts.geojson b/examples/dflowfm_local/geoms/culverts.geojson index 032d4cb2..89728507 100644 --- a/examples/dflowfm_local/geoms/culverts.geojson +++ b/examples/dflowfm_local/geoms/culverts.geojson @@ -2,10 +2,6 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -<<<<<<< HEAD -{ "type": "Feature", "properties": { "length": 1.0, "valveopeningheight": null, "type": "culvert", "relopening": null, "outletlosscoeff": 0.2, "inletlosscoeff": 0.2, "numlosscoeff": null, "csdefid": "rect_h1.500_w1.500_cyes_point", "allowedflowdir": "positive", "branchid": "branch_13", "leftlevel": 2.56, "rightlevel": 2.5, "bedfrictiontype": "Manning", "valveonoff": 0.0, "id": "culvert_1", "chainage": 331.832, "bedfriction": 0.012, "losscoeff": null }, "geometry": { "type": "Point", "coordinates": [ 665186.754018069244921, 1525896.07843215460889 ] } } -======= -{ "type": "Feature", "properties": { "bedfriction": 0.012, "length": 1.0, "numlosscoeff": null, "bedfrictiontype": "Manning", "losscoeff": null, "type": "culvert", "chainage": 331.832, "leftlevel": 2.56, "outletlosscoeff": 0.2, "csdefid": "rect_h1.500_w1.500_cyes_point", "valveonoff": 0.0, "inletlosscoeff": 0.2, "relopening": null, "branchid": "branch_13", "allowedflowdir": "positive", "valveopeningheight": null, "id": "culvert_1", "rightlevel": 2.5 }, "geometry": { "type": "Point", "coordinates": [ 665186.754018069244921, 1525896.07843215460889 ] } } ->>>>>>> main +{ "type": "Feature", "properties": { "bedfriction": 0.012, "csdefid": "rect_h1.500_w1.500_cyes_point", "inletlosscoeff": 0.2, "id": "culvert_1", "type": "culvert", "rightlevel": 2.5, "relopening": null, "numlosscoeff": null, "valveonoff": 0.0, "losscoeff": null, "bedfrictiontype": "Manning", "length": 1.0, "valveopeningheight": null, "allowedflowdir": "positive", "branchid": "branch_13", "outletlosscoeff": 0.2, "chainage": 331.832, "leftlevel": 2.56 }, "geometry": { "type": "Point", "coordinates": [ 665186.754018069244921, 1525896.07843215460889 ] } } ] } diff --git a/examples/dflowfm_local/geoms/pipe_nodes.geojson b/examples/dflowfm_local/geoms/pipe_nodes.geojson index a0c49c70..b4f3026c 100644 --- a/examples/dflowfm_local/geoms/pipe_nodes.geojson +++ b/examples/dflowfm_local/geoms/pipe_nodes.geojson @@ -2,25 +2,25 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_0", "branch_id": "pipe_4", "branchtype": "pipe", "branchid": "pipe_4", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_4" }, "geometry": { "type": "Point", "coordinates": [ 664438.813829420600086, 1525829.800284768920392 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_1", "branch_id": "pipe_4", "branchtype": "pipe", "branchid": "pipe_4", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_4" }, "geometry": { "type": "Point", "coordinates": [ 664429.038999999407679, 1526107.097999999299645 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_2", "branch_id": "pipe_5", "branchtype": "pipe", "branchid": "pipe_5", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_5" }, "geometry": { "type": "Point", "coordinates": [ 664190.385799999814481, 1525924.032600000267848 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_3", "branch_id": "pipe_6", "branchtype": "pipe", "branchid": "pipe_6", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_6" }, "geometry": { "type": "Point", "coordinates": [ 664217.490140905487351, 1525583.23970616585575 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_4", "branch_id": "pipe_7", "branchtype": "pipe", "branchid": "pipe_7", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_7" }, "geometry": { "type": "Point", "coordinates": [ 663936.864700614358298, 1525261.152571672573686 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_5", "branch_id": "pipe_8", "branchtype": "pipe", "branchid": "pipe_8", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_8" }, "geometry": { "type": "Point", "coordinates": [ 663871.550461587961763, 1525175.738024139311165 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_6", "branch_id": "pipe_9", "branchtype": "pipe", "branchid": "pipe_9", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_9" }, "geometry": { "type": "Point", "coordinates": [ 664048.325319660594687, 1525098.071112430887297 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_7", "branch_id": "pipe_10", "branchtype": "pipe", "branchid": "pipe_10", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_10" }, "geometry": { "type": "Point", "coordinates": [ 664702.726926030125469, 1525750.098550153663382 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_8", "branch_id": "pipe_10", "branchtype": "pipe", "branchid": "pipe_10", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_10" }, "geometry": { "type": "Point", "coordinates": [ 664481.894200000097044, 1525830.303300000727177 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_9", "branch_id": "pipe_11", "branchtype": "pipe", "branchid": "pipe_11", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_11" }, "geometry": { "type": "Point", "coordinates": [ 664474.13, 1526115.699999999254942 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_10", "branch_id": "pipe_12", "branchtype": "pipe", "branchid": "pipe_12", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_12" }, "geometry": { "type": "Point", "coordinates": [ 664747.433496630517766, 1525729.649799561593682 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_11", "branch_id": "pipe_12", "branchtype": "pipe", "branchid": "pipe_12", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_12" }, "geometry": { "type": "Point", "coordinates": [ 665030.18360000057146, 1525603.506899999454618 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_12", "branch_id": "pipe_13", "branchtype": "pipe", "branchid": "pipe_13", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_13" }, "geometry": { "type": "Point", "coordinates": [ 664849.475700000301003, 1525031.354499999433756 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_13", "branch_id": "pipe_13", "branchtype": "pipe", "branchid": "pipe_13", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_13" }, "geometry": { "type": "Point", "coordinates": [ 665115.70000000030268, 1524944.7899999988731 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_14", "branch_id": "pipe_14", "branchtype": "pipe", "branchid": "pipe_14", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_14" }, "geometry": { "type": "Point", "coordinates": [ 665219.643113493453711, 1525514.959856803994626 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_15", "branch_id": "pipe_15", "branchtype": "pipe", "branchid": "pipe_15", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_15" }, "geometry": { "type": "Point", "coordinates": [ 664708.738620752468705, 1524483.144798168679699 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_16", "branch_id": "pipe_16", "branchtype": "pipe", "branchid": "pipe_16", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_16" }, "geometry": { "type": "Point", "coordinates": [ 665277.574117646785453, 1525446.393194784643129 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_17", "branch_id": "pipe_16", "branchtype": "pipe", "branchid": "pipe_16", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_16" }, "geometry": { "type": "Point", "coordinates": [ 665356.868200001074001, 1525406.983500000322238 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_18", "branch_id": "pipe_17", "branchtype": "pipe", "branchid": "pipe_17", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_17" }, "geometry": { "type": "Point", "coordinates": [ 665292.615320706507191, 1525470.849516379414126 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_19", "branch_id": "pipe_17", "branchtype": "pipe", "branchid": "pipe_17", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_17" }, "geometry": { "type": "Point", "coordinates": [ 665369.906399999978021, 1525431.441199998836964 ] } } +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_0", "branch_id": "pipe_4", "branchid": "pipe_4", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_4" }, "geometry": { "type": "Point", "coordinates": [ 664438.813829420600086, 1525829.800284768920392 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_1", "branch_id": "pipe_4", "branchid": "pipe_4", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_4" }, "geometry": { "type": "Point", "coordinates": [ 664429.038999999407679, 1526107.097999999299645 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_2", "branch_id": "pipe_5", "branchid": "pipe_5", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_5" }, "geometry": { "type": "Point", "coordinates": [ 664190.385799999814481, 1525924.032600000267848 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_3", "branch_id": "pipe_6", "branchid": "pipe_6", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_6" }, "geometry": { "type": "Point", "coordinates": [ 664217.490140905487351, 1525583.23970616585575 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_4", "branch_id": "pipe_7", "branchid": "pipe_7", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_7" }, "geometry": { "type": "Point", "coordinates": [ 663936.864700614358298, 1525261.152571672573686 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_5", "branch_id": "pipe_8", "branchid": "pipe_8", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_8" }, "geometry": { "type": "Point", "coordinates": [ 663871.550461587961763, 1525175.738024139311165 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_6", "branch_id": "pipe_9", "branchid": "pipe_9", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_9" }, "geometry": { "type": "Point", "coordinates": [ 664048.325319660594687, 1525098.071112430887297 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_7", "branch_id": "pipe_10", "branchid": "pipe_10", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_10" }, "geometry": { "type": "Point", "coordinates": [ 664702.726926030125469, 1525750.098550153663382 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_8", "branch_id": "pipe_10", "branchid": "pipe_10", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_10" }, "geometry": { "type": "Point", "coordinates": [ 664481.894200000097044, 1525830.303300000727177 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_9", "branch_id": "pipe_11", "branchid": "pipe_11", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_11" }, "geometry": { "type": "Point", "coordinates": [ 664474.13, 1526115.699999999254942 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_10", "branch_id": "pipe_12", "branchid": "pipe_12", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_12" }, "geometry": { "type": "Point", "coordinates": [ 664747.433496630517766, 1525729.649799561593682 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_11", "branch_id": "pipe_12", "branchid": "pipe_12", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_12" }, "geometry": { "type": "Point", "coordinates": [ 665030.18360000057146, 1525603.506899999454618 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_12", "branch_id": "pipe_13", "branchid": "pipe_13", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_13" }, "geometry": { "type": "Point", "coordinates": [ 664849.475700000301003, 1525031.354499999433756 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_13", "branch_id": "pipe_13", "branchid": "pipe_13", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_13" }, "geometry": { "type": "Point", "coordinates": [ 665115.70000000030268, 1524944.7899999988731 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_14", "branch_id": "pipe_14", "branchid": "pipe_14", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_14" }, "geometry": { "type": "Point", "coordinates": [ 665219.643113493453711, 1525514.959856803994626 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_15", "branch_id": "pipe_15", "branchid": "pipe_15", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_15" }, "geometry": { "type": "Point", "coordinates": [ 664708.738620752468705, 1524483.144798168679699 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_16", "branch_id": "pipe_16", "branchid": "pipe_16", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_16" }, "geometry": { "type": "Point", "coordinates": [ 665277.574117646785453, 1525446.393194784643129 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_17", "branch_id": "pipe_16", "branchid": "pipe_16", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_16" }, "geometry": { "type": "Point", "coordinates": [ 665356.868200001074001, 1525406.983500000322238 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_18", "branch_id": "pipe_17", "branchid": "pipe_17", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_17" }, "geometry": { "type": "Point", "coordinates": [ 665292.615320706507191, 1525470.849516379414126 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_19", "branch_id": "pipe_17", "branchid": "pipe_17", "branchtype": "pipe", "branchorder": -1.0, "closed": "yes", "ORIG_branchid": "pipe_17" }, "geometry": { "type": "Point", "coordinates": [ 665369.906399999978021, 1525431.441199998836964 ] } } ] } diff --git a/examples/dflowfm_local/geoms/pipes.geojson b/examples/dflowfm_local/geoms/pipes.geojson index 92621192..f662649d 100644 --- a/examples/dflowfm_local/geoms/pipes.geojson +++ b/examples/dflowfm_local/geoms/pipes.geojson @@ -2,19 +2,19 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_4", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_4", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_0_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664438.813829420600086, 1525829.800284768920392 ], [ 664429.038999999989755, 1526107.098 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_5", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_5", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_1_generated", "manhole_dn": "manhole_0_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664190.385799999814481, 1525924.032600000267848 ], [ 664438.813829420600086, 1525829.800284768920392 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_6", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_2_generated", "manhole_dn": "manhole_0_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664217.490140905487351, 1525583.23970616585575 ], [ 664438.813829420600086, 1525829.800284768920392 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_7", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_3_generated", "manhole_dn": "manhole_2_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 663936.864700614358298, 1525261.152571672573686 ], [ 664217.490140905487351, 1525583.23970616585575 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_8", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_4_generated", "manhole_dn": "manhole_3_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 663871.550461587961763, 1525175.738024139311165 ], [ 663897.086400000494905, 1525212.559499999275431 ], [ 663936.864700614358298, 1525261.152571672573686 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_9", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_5_generated", "manhole_dn": "manhole_4_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664048.325319660594687, 1525098.071112430887297 ], [ 663871.550461587961763, 1525175.738024139311165 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_10", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_6_generated", "manhole_dn": "manhole_7_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664702.726926030125469, 1525750.098550153663382 ], [ 664481.894200000097044, 1525830.303300000727177 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_11", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_7_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664481.894200000097044, 1525830.303300000727177 ], [ 664474.13, 1526115.7 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_12", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_8_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664747.433496630517766, 1525729.649799561593682 ], [ 664838.810497992672026, 1525698.612855288665742 ], [ 664907.926478271954693, 1525663.288345249835402 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_13", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_13", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_9_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664849.475700000301003, 1525031.354499999433756 ], [ 665115.699999999953434, 1524944.79 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_14", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_14", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_10_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665219.643113493453711, 1525514.959856803994626 ], [ 665030.18360000057146, 1525603.506899999454618 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_15", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_15", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_11_generated", "manhole_dn": "manhole_9_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664708.738620752468705, 1524483.144798168679699 ], [ 664849.475700000301003, 1525031.354499999433756 ], [ 664849.475700000301003, 1525031.354499999433756 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_16", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_16", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_12_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665277.574117646785453, 1525446.393194784643129 ], [ 665356.868200000026263, 1525406.9835 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "pipe", "branchid": "pipe_17", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_17", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_13_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665292.615320706507191, 1525470.849516379414126 ], [ 665369.906399999978021, 1525431.4412 ], [ 665369.906399999978021, 1525431.4412 ] ] } } +{ "type": "Feature", "properties": { "branchid": "pipe_4", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_4", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_0_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664438.813829420600086, 1525829.800284768920392 ], [ 664429.038999999989755, 1526107.098 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_5", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_5", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_1_generated", "manhole_dn": "manhole_0_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664190.385799999814481, 1525924.032600000267848 ], [ 664438.813829420600086, 1525829.800284768920392 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_6", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_2_generated", "manhole_dn": "manhole_0_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664217.490140905487351, 1525583.23970616585575 ], [ 664438.813829420600086, 1525829.800284768920392 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_7", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_3_generated", "manhole_dn": "manhole_2_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 663936.864700614358298, 1525261.152571672573686 ], [ 664217.490140905487351, 1525583.23970616585575 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_8", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_4_generated", "manhole_dn": "manhole_3_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 663871.550461587961763, 1525175.738024139311165 ], [ 663897.086400000494905, 1525212.559499999275431 ], [ 663936.864700614358298, 1525261.152571672573686 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_9", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_5_generated", "manhole_dn": "manhole_4_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664048.325319660594687, 1525098.071112430887297 ], [ 663871.550461587961763, 1525175.738024139311165 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_10", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_6_generated", "manhole_dn": "manhole_7_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664702.726926030125469, 1525750.098550153663382 ], [ 664481.894200000097044, 1525830.303300000727177 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_11", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_7_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664481.894200000097044, 1525830.303300000727177 ], [ 664474.13, 1526115.7 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_12", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_8_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664747.433496630517766, 1525729.649799561593682 ], [ 664838.810497992672026, 1525698.612855288665742 ], [ 664907.926478271954693, 1525663.288345249835402 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_13", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_13", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_9_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 664849.475700000301003, 1525031.354499999433756 ], [ 665115.699999999953434, 1524944.79 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_14", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_14", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_10_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665219.643113493453711, 1525514.959856803994626 ], [ 665030.18360000057146, 1525603.506899999454618 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_15", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_15", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_11_generated", "manhole_dn": "manhole_9_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 664708.738620752468705, 1524483.144798168679699 ], [ 664849.475700000301003, 1525031.354499999433756 ], [ 664849.475700000301003, 1525031.354499999433756 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_16", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_16", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_12_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665277.574117646785453, 1525446.393194784643129 ], [ 665356.868200000026263, 1525406.9835 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "pipe_17", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "width": null, "t_width": null, "height": null, "bedlev": null, "closed": "yes", "ORIG_branchid": "pipe_17", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "diameter": 0.5, "index_right": 0.0, "OBJECTID": 1.0, "invlev_up": -2.5, "invlev_dn": -2.5, "manhole_up": "manhole_13_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 665292.615320706507191, 1525470.849516379414126 ], [ 665369.906399999978021, 1525431.4412 ], [ 665369.906399999978021, 1525431.4412 ] ] } } ] } diff --git a/examples/dflowfm_local/geoms/rivers.geojson b/examples/dflowfm_local/geoms/rivers.geojson index be83a827..ee341cab 100644 --- a/examples/dflowfm_local/geoms/rivers.geojson +++ b/examples/dflowfm_local/geoms/rivers.geojson @@ -2,19 +2,19 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "river_1", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "river_1", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664057.966296999948099, 1526147.834882 ], [ 663918.391924358904362, 1525803.10090322420001 ], [ 663700.482064640615135, 1525466.331120023271069 ], [ 663353.045365229598247, 1525088.417517154943198 ], [ 662879.129516471526586, 1524643.454726681346074 ], [ 662793.794186791637912, 1524515.451732161454856 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "river_2", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "river_2", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664057.966296999948099, 1526147.834882 ], [ 664218.310854589915834, 1526625.788610660471022 ], [ 664218.310854589915834, 1527005.169120056321844 ], [ 664197.234159623389132, 1527152.705984821310267 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_1", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_1", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665115.699999999953434, 1524944.79 ], [ 665356.868200000026263, 1525406.9835 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_2", "branchorder": 2.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_2", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665356.868200000026263, 1525406.9835 ], [ 665369.906399999978021, 1525431.441199999069795 ], [ 665369.906399999978021, 1525431.4412 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_3", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_3", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665369.906399999978021, 1525431.4412 ], [ 665641.789999999804422, 1525937.96000000089407 ], [ 665641.789999999804422, 1525937.96000000089407 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_4", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_4", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665641.789999999804422, 1525937.96000000089407 ], [ 665560.620547444559634, 1525952.124135404126719 ], [ 665480.575254552299157, 1525953.687039414886385 ], [ 665416.820000000414439, 1525962.189999999245629 ], [ 665346.659376955241896, 1525982.895817694021389 ], [ 665271.309999999706633, 1526001.859999999403954 ], [ 665243.630000000470318, 1526003.289999998640269 ], [ 665243.630000000470318, 1526003.289999997941777 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_5", "branchorder": 3.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_5", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665243.630000000470318, 1526003.289999997941777 ], [ 665116.950000000419095, 1525983.029999999096617 ], [ 665051.90000000083819, 1525977.32 ], [ 664963.504724813159555, 1526014.666760261869058 ], [ 664918.370000000344589, 1526039.810000000521541 ], [ 664826.210000000428408, 1526041.519999999552965 ], [ 664752.459499345044605, 1526065.157490010838956 ], [ 664672.28994727297686, 1526086.417805780190974 ], [ 664642.852168873418123, 1526095.560649296734482 ], [ 664550.869999999529682, 1526115.410000000149012 ], [ 664474.13, 1526115.7 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_6", "branchorder": 4.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_6", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664474.13, 1526115.7 ], [ 664429.038999999989755, 1526107.098 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_7", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_7", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664429.038999999989755, 1526107.098 ], [ 664272.40999999945052, 1526129.970000000204891 ], [ 664169.979999999864958, 1526140.529999999562278 ], [ 664092.240000000223517, 1526143.2899999988731 ], [ 664057.966296999948099, 1526147.834882 ], [ 664057.966296999948099, 1526147.834882 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_8", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_8", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 666180.040000000037253, 1525894.769999999320135 ], [ 665891.336423385655507, 1526041.311705864733085 ], [ 665733.269999999320135, 1526117.310000000521541 ], [ 665733.269999999320135, 1526117.310000000521541 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_10", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_10", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665733.269999999320135, 1526117.310000000521541 ], [ 665641.789999999804422, 1525937.96000000089407 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_11", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_11", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664789.146172603359446, 1525073.346127192256972 ], [ 665015.157200000365265, 1525576.51439999951981 ], [ 665015.157200000365265, 1525576.514399999286979 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_12", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_12", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665015.157200000365265, 1525576.514399999286979 ], [ 665030.18360000057146, 1525603.506899999454618 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, -{ "type": "Feature", "properties": { "branchtype": "river", "branchid": "branch_13", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_13", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665030.18360000057146, 1525603.506899999454618 ], [ 665243.630000000470318, 1526003.289999997941777 ] ] } } +{ "type": "Feature", "properties": { "branchid": "river_1", "branchtype": "river", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "river_1", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664057.966296999948099, 1526147.834882 ], [ 663918.391924358904362, 1525803.10090322420001 ], [ 663700.482064640615135, 1525466.331120023271069 ], [ 663353.045365229598247, 1525088.417517154943198 ], [ 662879.129516471526586, 1524643.454726681346074 ], [ 662793.794186791637912, 1524515.451732161454856 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "river_2", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "river_2", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664057.966296999948099, 1526147.834882 ], [ 664218.310854589915834, 1526625.788610660471022 ], [ 664218.310854589915834, 1527005.169120056321844 ], [ 664197.234159623389132, 1527152.705984821310267 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_1", "branchtype": "river", "branchorder": 1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_1", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665115.699999999953434, 1524944.79 ], [ 665356.868200000026263, 1525406.9835 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_2", "branchtype": "river", "branchorder": 2.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_2", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665356.868200000026263, 1525406.9835 ], [ 665369.906399999978021, 1525431.441199999069795 ], [ 665369.906399999978021, 1525431.4412 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_3", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_3", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665369.906399999978021, 1525431.4412 ], [ 665641.789999999804422, 1525937.96000000089407 ], [ 665641.789999999804422, 1525937.96000000089407 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_4", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_4", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665641.789999999804422, 1525937.96000000089407 ], [ 665560.620547444559634, 1525952.124135404126719 ], [ 665480.575254552299157, 1525953.687039414886385 ], [ 665416.820000000414439, 1525962.189999999245629 ], [ 665346.659376955241896, 1525982.895817694021389 ], [ 665271.309999999706633, 1526001.859999999403954 ], [ 665243.630000000470318, 1526003.289999998640269 ], [ 665243.630000000470318, 1526003.289999997941777 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_5", "branchtype": "river", "branchorder": 3.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_5", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665243.630000000470318, 1526003.289999997941777 ], [ 665116.950000000419095, 1525983.029999999096617 ], [ 665051.90000000083819, 1525977.32 ], [ 664963.504724813159555, 1526014.666760261869058 ], [ 664918.370000000344589, 1526039.810000000521541 ], [ 664826.210000000428408, 1526041.519999999552965 ], [ 664752.459499345044605, 1526065.157490010838956 ], [ 664672.28994727297686, 1526086.417805780190974 ], [ 664642.852168873418123, 1526095.560649296734482 ], [ 664550.869999999529682, 1526115.410000000149012 ], [ 664474.13, 1526115.7 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_6", "branchtype": "river", "branchorder": 4.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_6", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664474.13, 1526115.7 ], [ 664429.038999999989755, 1526107.098 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_7", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_7", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664429.038999999989755, 1526107.098 ], [ 664272.40999999945052, 1526129.970000000204891 ], [ 664169.979999999864958, 1526140.529999999562278 ], [ 664092.240000000223517, 1526143.2899999988731 ], [ 664057.966296999948099, 1526147.834882 ], [ 664057.966296999948099, 1526147.834882 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_8", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_8", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 666180.040000000037253, 1525894.769999999320135 ], [ 665891.336423385655507, 1526041.311705864733085 ], [ 665733.269999999320135, 1526117.310000000521541 ], [ 665733.269999999320135, 1526117.310000000521541 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_10", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_10", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665733.269999999320135, 1526117.310000000521541 ], [ 665641.789999999804422, 1525937.96000000089407 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_11", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_11", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 664789.146172603359446, 1525073.346127192256972 ], [ 665015.157200000365265, 1525576.51439999951981 ], [ 665015.157200000365265, 1525576.514399999286979 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_12", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_12", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665015.157200000365265, 1525576.514399999286979 ], [ 665030.18360000057146, 1525603.506899999454618 ], [ 665030.18360000057146, 1525603.506899999454618 ] ] } }, +{ "type": "Feature", "properties": { "branchid": "branch_13", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_13", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "diameter": null, "index_right": null, "OBJECTID": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 665030.18360000057146, 1525603.506899999454618 ], [ 665243.630000000470318, 1526003.289999997941777 ] ] } } ] } diff --git a/examples/dflowfm_local/geoms/rivers_nodes.geojson b/examples/dflowfm_local/geoms/rivers_nodes.geojson index 44f9b892..c6483081 100644 --- a/examples/dflowfm_local/geoms/rivers_nodes.geojson +++ b/examples/dflowfm_local/geoms/rivers_nodes.geojson @@ -2,22 +2,22 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::32647" } }, "features": [ -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_0", "branch_id": "branch_1", "branchtype": "river", "branchid": "branch_1", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_1" }, "geometry": { "type": "Point", "coordinates": [ 665115.70000000030268, 1524944.7899999988731 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_1", "branch_id": "branch_1", "branchtype": "river", "branchid": "branch_1", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_1" }, "geometry": { "type": "Point", "coordinates": [ 665356.868200001074001, 1525406.983500000322238 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_2", "branch_id": "branch_2", "branchtype": "river", "branchid": "branch_2", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_2" }, "geometry": { "type": "Point", "coordinates": [ 665369.906399999978021, 1525431.441199999069795 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_3", "branch_id": "branch_3", "branchtype": "river", "branchid": "branch_3", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_3" }, "geometry": { "type": "Point", "coordinates": [ 665369.906399999978021, 1525431.441199998836964 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_4", "branch_id": "branch_3", "branchtype": "river", "branchid": "branch_3", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_3" }, "geometry": { "type": "Point", "coordinates": [ 665641.789999999804422, 1525937.96000000089407 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_5", "branch_id": "branch_4", "branchtype": "river", "branchid": "branch_4", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_4" }, "geometry": { "type": "Point", "coordinates": [ 665243.630000000470318, 1526003.289999998640269 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_6", "branch_id": "branch_5", "branchtype": "river", "branchid": "branch_5", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_5" }, "geometry": { "type": "Point", "coordinates": [ 665243.630000000470318, 1526003.289999998174608 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_7", "branch_id": "branch_5", "branchtype": "river", "branchid": "branch_5", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_5" }, "geometry": { "type": "Point", "coordinates": [ 664474.13, 1526115.699999999254942 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_8", "branch_id": "branch_6", "branchtype": "river", "branchid": "branch_6", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_6" }, "geometry": { "type": "Point", "coordinates": [ 664429.038999999407679, 1526107.097999999299645 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_9", "branch_id": "branch_7", "branchtype": "river", "branchid": "branch_7", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_7" }, "geometry": { "type": "Point", "coordinates": [ 664057.966297403792851, 1526147.834882111055776 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_10", "branch_id": "branch_8", "branchtype": "river", "branchid": "branch_8", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_8" }, "geometry": { "type": "Point", "coordinates": [ 666180.040000000037253, 1525894.769999999320135 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_11", "branch_id": "branch_8", "branchtype": "river", "branchid": "branch_8", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_8" }, "geometry": { "type": "Point", "coordinates": [ 665733.269999999320135, 1526117.310000000521541 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_12", "branch_id": "branch_11", "branchtype": "river", "branchid": "branch_11", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_11" }, "geometry": { "type": "Point", "coordinates": [ 664789.146172603359446, 1525073.346127192256972 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_13", "branch_id": "branch_11", "branchtype": "river", "branchid": "branch_11", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_11" }, "geometry": { "type": "Point", "coordinates": [ 665015.157200000365265, 1525576.51439999951981 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_14", "branch_id": "branch_12", "branchtype": "river", "branchid": "branch_12", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_12" }, "geometry": { "type": "Point", "coordinates": [ 665015.157200000365265, 1525576.514399999286979 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_15", "branch_id": "branch_12", "branchtype": "river", "branchid": "branch_12", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_12" }, "geometry": { "type": "Point", "coordinates": [ 665030.18360000057146, 1525603.506899999454618 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_16", "branch_id": "branch_13", "branchtype": "river", "branchid": "branch_13", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_13" }, "geometry": { "type": "Point", "coordinates": [ 665243.630000000470318, 1526003.289999997941777 ] } } +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_0", "branch_id": "branch_1", "branchid": "branch_1", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_1" }, "geometry": { "type": "Point", "coordinates": [ 665115.70000000030268, 1524944.7899999988731 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_1", "branch_id": "branch_1", "branchid": "branch_1", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_1" }, "geometry": { "type": "Point", "coordinates": [ 665356.868200001074001, 1525406.983500000322238 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_2", "branch_id": "branch_2", "branchid": "branch_2", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_2" }, "geometry": { "type": "Point", "coordinates": [ 665369.906399999978021, 1525431.441199999069795 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_3", "branch_id": "branch_3", "branchid": "branch_3", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_3" }, "geometry": { "type": "Point", "coordinates": [ 665369.906399999978021, 1525431.441199998836964 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_4", "branch_id": "branch_3", "branchid": "branch_3", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_3" }, "geometry": { "type": "Point", "coordinates": [ 665641.789999999804422, 1525937.96000000089407 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_5", "branch_id": "branch_4", "branchid": "branch_4", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_4" }, "geometry": { "type": "Point", "coordinates": [ 665243.630000000470318, 1526003.289999998640269 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_6", "branch_id": "branch_5", "branchid": "branch_5", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_5" }, "geometry": { "type": "Point", "coordinates": [ 665243.630000000470318, 1526003.289999998174608 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_7", "branch_id": "branch_5", "branchid": "branch_5", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_5" }, "geometry": { "type": "Point", "coordinates": [ 664474.13, 1526115.699999999254942 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_8", "branch_id": "branch_6", "branchid": "branch_6", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_6" }, "geometry": { "type": "Point", "coordinates": [ 664429.038999999407679, 1526107.097999999299645 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_9", "branch_id": "branch_7", "branchid": "branch_7", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_7" }, "geometry": { "type": "Point", "coordinates": [ 664057.966297403792851, 1526147.834882111055776 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_10", "branch_id": "branch_8", "branchid": "branch_8", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_8" }, "geometry": { "type": "Point", "coordinates": [ 666180.040000000037253, 1525894.769999999320135 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_11", "branch_id": "branch_8", "branchid": "branch_8", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_8" }, "geometry": { "type": "Point", "coordinates": [ 665733.269999999320135, 1526117.310000000521541 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_12", "branch_id": "branch_11", "branchid": "branch_11", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_11" }, "geometry": { "type": "Point", "coordinates": [ 664789.146172603359446, 1525073.346127192256972 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_13", "branch_id": "branch_11", "branchid": "branch_11", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_11" }, "geometry": { "type": "Point", "coordinates": [ 665015.157200000365265, 1525576.51439999951981 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_14", "branch_id": "branch_12", "branchid": "branch_12", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_12" }, "geometry": { "type": "Point", "coordinates": [ 665015.157200000365265, 1525576.514399999286979 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_15", "branch_id": "branch_12", "branchid": "branch_12", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_12" }, "geometry": { "type": "Point", "coordinates": [ 665030.18360000057146, 1525603.506899999454618 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_16", "branch_id": "branch_13", "branchid": "branch_13", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "width": 10.0, "t_width": 20.0, "height": 10.0, "bedlev": -10.0, "closed": "no", "ORIG_branchid": "branch_13" }, "geometry": { "type": "Point", "coordinates": [ 665243.630000000470318, 1526003.289999997941777 ] } } ] } diff --git a/examples/dflowfm_piave/dflowfm/bnd.ext b/examples/dflowfm_piave/dflowfm/bnd.ext index 6cb88202..381d622d 100644 --- a/examples/dflowfm_piave/dflowfm/bnd.ext +++ b/examples/dflowfm_piave/dflowfm/bnd.ext @@ -6,33 +6,18 @@ fileType = extForce [Boundary] quantity = waterlevelbnd -<<<<<<< HEAD -nodeId = 1383191.056228_5854440.811426 -forcingFile = boundarycondition1d.bc - -[Boundary] -quantity = waterlevelbnd -nodeId = 1394694.070276_5867648.108302 -forcingFile = boundarycondition1d.bc - -[Boundary] -quantity = waterlevelbnd -nodeId = 1386066.809740_5868052.726493 -forcingFile = boundarycondition1d.bc -======= nodeId = 1384118.718651_5855518.214933 -forcingFile = boundaryconditions1d_waterlevelbnd.bc +forcingFile = boundarycondition1d.bc [Boundary] quantity = waterlevelbnd nodeId = 1393117.044157_5866704.071640 -forcingFile = boundaryconditions1d_waterlevelbnd.bc +forcingFile = boundarycondition1d.bc [Boundary] quantity = waterlevelbnd nodeId = 1387829.368344_5866704.071640 -forcingFile = boundaryconditions1d_waterlevelbnd.bc ->>>>>>> main +forcingFile = boundarycondition1d.bc [Boundary] quantity = waterlevelbnd diff --git a/examples/dflowfm_piave/dflowfm/boundaryconditions1d_waterlevelbnd.bc b/examples/dflowfm_piave/dflowfm/boundaryconditions1d_waterlevelbnd.bc deleted file mode 100644 index 135fc0ee..00000000 --- a/examples/dflowfm_piave/dflowfm/boundaryconditions1d_waterlevelbnd.bc +++ /dev/null @@ -1,42 +0,0 @@ -# written by HYDROLIB-core 0.5.2 - -[General] -fileVersion = 1.01 -fileType = boundConds - -[Forcing] -name = 1384118.718651_5855518.214933 -function = constant -offset = 0.0 -factor = 1.0 -quantity = waterlevelbnd -unit = m --2.0 - -[Forcing] -name = 1393117.044157_5866704.071640 -function = constant -offset = 0.0 -factor = 1.0 -quantity = waterlevelbnd -unit = m --2.0 - -[Forcing] -name = 1387829.368344_5866704.071640 -function = constant -offset = 0.0 -factor = 1.0 -quantity = waterlevelbnd -unit = m --2.0 - -[Forcing] -name = 1391540.018037_5858077.577220 -function = constant -offset = 0.0 -factor = 1.0 -quantity = waterlevelbnd -unit = m --2.0 - diff --git a/examples/dflowfm_piave/dflowfm/fm_net.nc b/examples/dflowfm_piave/dflowfm/fm_net.nc index c8f776c12a89ad8e32392d71de7a675d070836ef..eede79db584b4a652f5617c3c3e193ca0e754eea 100644 GIT binary patch delta 71319 zcmZ^s2Xs_b_x6*SBtYn30~83-RD?{QvA{vGAW9L$hBUEJ6i^fa8JaYaHo(v!^iB#8 zItgOOg4kXaCH5}Z6_x+9_j&H*=3DD?t-F4EpL6d%{oZr-9?949!XFg{XAeq0G-vQN zo~$Et^3U^Ry*lTmXVPCt^hiHi!8@<1}yAg^BO8=4LghmFAtiJ29!!1WnC*DN(KR-0TLe(!B3|otBnXC$S>q z{KTQkQ?kN$q+iW_XyUPIL%bO;o=kjRtuQO21P|0ojL)u{ z*j{~!r|Hnd%{A`#bZDH|QDcNRt88SVRn5ts3tJ|>uG%PZyyg_ol`9jyYVGxO>Xmr2 zN`pk8_N$(OZ_lmsxM$$|iIH`7WncGaTIEsm)MQ!hx`|G8S7b_3NzqSrpYV9HCM6y` z?_*Ea)WnVFf9yH$#-f%Nv`zOkubdcsZiB?cdS^VLmx{*KuaWNQeljt;!N;DVD-%O6 z{MZvuE9!a?ZhW?HVs^s?o+TwkEgLmS&kEi3@VNWL}U~?Y|?5!8yTCK98*M7PctB}#ItBzz0RY9#DKQGcSMsJu59O6@&Vf>6>?U2WDey*uVdTG>9- zcJ>@pEGH=?`Eup4vY)dWB!+g(P7F^r)x;yh0+Q!{d-0jR~OsoaDvf-23h&m6PQ_;Znp zQDAD$QnlolM==ge9cEJlVWb}W*QTPj&`SSvv>-HTh*;0|;(2L_Ejc75%Xrw5`z_Nl z!t%Tfh)pe6CQb8)@nkHSKHp=TmJyL>%i9zQ2i^w^n7lcDjB)*q%_THQE1XM)qL{2j*;ByLk+ZPx}H8=A)^%V%i}Ui zc9r>8YATXpv^Its4`v4Nplz924NCdaFslVawp~_>Lem+S+a^2FBu}k{!bp^nl3NnP z@}zCBiNw=qSktgPmugeQ4=vTEh&-NZQ#2Qv)22kfRcb6MkL$XThQ{Ra(=~1FGh*_1 zSuKpAyfQL!<#}nEs+qZ{21m_iizOX3sM%hBn1d!-V%2JCPtc!>R2?jR#2*y(Z;X;v zqfpb)FslZ{gtU`t7^*bXszEWO6H}iJiYc9$q9)4LNb7B)5DQ|5AmfWq4h%KkJRWhQvk@Dt34MNp9ss%@*qW*=dmkgDzfu^liEeuT> zEiYa4F*F@p)x?aBt!iRL$F?M7jp)#dA~tkndLJ_F{4vgwP>_;GOr&dvS=YcG~b_WLMRMP8moEXTxil*s|BH@ z8XFcXI>23@kZysdZp;Z$rsn$ls ziql$8B%J(lvF9R`mhH)nIW5ihhVaeTVMT^F1|`+bSO8k8ov{csJE}S8S06Mxs-lSz zJB39PE93Xe_(SuF6>X<#V#SUs^88}Oj;d&4#g3|IV#SUsw18N#lUOvdGX7q?hlfr| z&(46AsO+5TtLh2mCVyJ&xzH-HTy1LdR2Otz0DA*ztJNaV>=cH{un(G@!lH$sr5YQK z$#e2bmL^2R%A9?UCRS37jf$02W20gv)!3+5VPkDo*w$>X*wCh8^MtOIr|!f;Q%!70 zQ$@?ng$>(O-Dmj%K5eR1B0f8+@|fR;J%SFaY9ZM%$ZAzB22Gl};2G%?C5SBL))pE*k~_1Hr2#Ns-Y37NUEU` zSaCHp>hqU3G#c`kH#8c<#v#?vSU|QBPD5i6Xr;0hl5HkB7OFIrYDk_$W2uTEX|1Se z5;SS8)x?mr*52wDL(*QVVyK_&iL@9$49)LWslnW?l@nb%w@R$(+%&PWb4Jo%jQ#GL zn^6&LvvYMzt!g4?YO^fA-PRA=jeYX$o>jcENyiXbMfT`=2xxo{_vo^>hLT91*DUdI zm#k#L-&q&V?OIKb1#`Pr(OrGs895CcO~-QA#d%>O|K2LzFcjZ@u7o~_!;Gxfws_`|EP$GVNj%jL%U_@2?H|T(a1Q4*EjuFTpJSM&ROKKe3o_ZaP+suR`pGm^P0lkqX`xm1 zNEW`V_BlO9=?qq@F)^bXV6)cViYd?_2_@SrR&=AUn$!l9paG_un$(Zd?4Hk-VT-!Bk)#tmsKdve2tK z7xbx+*w9y^WJ&iX%jCVGn%L0yhH6q1of4;ZV-D$80g`Qt9t7pCs92D>AQm#CuwV~X zYA`A$WGZN;^eVRna{Tj)0a%|N}pm};~)mOIWiIr|L>f;Wf z3&e`f0cce{P-F_|V_`8e2Rm!4NmX@@u(ODpx9%OY_rkYemXF=n8)S|xj8{dN& zhK$-W=%R=PodNPpOsb(rc-6#$%mBQnusyR!VU@)~0k%1+hy@vcQG8-RhF=wVUUmYa zXphR^t0D$u{8bSHJ`A`h+MP1`P;fwVPSta}R!#RO8!hzUEtQ>tr|qyq(FTmaPEC13 ze*3)onUh~u;phGQrKCvRs z3jH+b;a-MXw5lFt$w=EQHBuET=FOp%i_DN4n|lM;Phy!|l*nCJ*&Bg^&K3oGXDI4L z5+xLCJzqRZBFB&+--<-Z@+$hger{@A>&f;Y2ldA%s-wpmKo_W{S@?+CEKe+!5MNW* zwJ?C~J1T%JI+O?$RN%s7Nl!5V4fBOs2pVP_wHUOrs;JS)&DI7!>{byQcwg*GvNrF19Kk0 zTUE4(51MZMR0~1VkAiA3X!24?j=M^_MV`Z}$!cOn4;pf3Osu3T6N433Wn!_Q-Rt*l zB-?0Zr*v7(g`Eg)93GSD&u zu)@kf#as{Ao{_vDc9ZJk+#th-zJZmT9% z^y@Fn$tzamjgnMNtc=HZ$7-_CZr_3BMP;L{$3n3ZmF>E`L17a{pvWs&71^w_CO8>F zk&5VY&BzrSvV)-NoExm_(@nqBMb>tPPfrd~8LP@UNNQtMzZ|D@Tc){wISc9MT-AUa zhNMRJ=75}rq)t@DRC%p}Vye7WK{2Hr1XF06Jc@ZNk7lFS`L-UoeMR4HMU8`nB7sp<+Z7!Mrwb3=qI$*alB!Hdye^0_SgRrRy2xHp z$`6Sd-Bos7O9zl_N<=w$C5WJyb$=49hoMo^KEz!@Fm1zSxr|VU_M)L~Xc{ZGb;nuuVIH$anR7}SvIe{Hk zT*5qF-Q6Bw$$5)hm2!eS<>nHn-TAsr#;DsyYrN-lC+!0Clx}iUPfE~-(`98#yVb;K z+t!vXE-w>D580_=xUaDx4c`)*shT}})SgoHTB@>N>$lQToiLCs)jof$!t)vuDvR@h zM9xyTag7XN;H~k*unL(@fT-Ly+KAHI@3Z&gFaS-OFXcK>qVl`(5@4vvm6qtY%v}N9 zTgxP{RWER7X4>dcw{BH!$Jppmc~@xksJttj=#i^1?78vn#^=(NmdIP~u7HM<@CslB zPBT*jH%?H=K5dg2S#l>ycuD$1Z_x0PP6>&+FucU#8Drv16wRyk!>n*3O`I_DtP^i4 zFN#4Y=@2bTgHF;PR+He7bcfX#bV@xfk*Ab(ECJjsvqEl0_(^X=fFI>*5UTzEXvYac zrR>O25zpd7<4zKDsXowfl+y8ky?$EX&i#)Unm*5sj}nktut>rZGIF z)56{(P1R`u72g_cWOY`EhVT@-TW@uuR4#LP58(md(@u$gi4M(K=%^a1lHRcO2{2UU zHsHjoDx`@~T_{p6f>xT@(i&mx%6-2Rz;dT)6iYhBJ{1;|v0P7N+E7+`&uA#i z=^1=LC4A&`4OE7*Toy7ko;Bi&&yt?e;Ecwzbec%0CYSLnYs=oipjIjg zLxb{lmN=0uoh0(S6WL1LEZ+y*jT4qTNlfZgk!LiU5%bleAC|NfWJ<q zP8_WKX$%IojM^D`gNCuBGepy1n0AJ0vendiA(|5mbD0W?DeMg0Nor3zL!QyFn0AJ0 z42#*@E5yd!Nn%vjN-98>>I^49R$gFc1V&@Y+H0`Eka(EvhuIf4QpT=GMas$_&4|fP zKh+Z&F0<1DF(VC^*=Zq~oEYp15ls#Zc@ddT(424?4QrCd%ydTJ2925786g^DX0F?v zz?myaqi1$`;2DjcrLV*5qda;h+a{~RpzQ!v^&E~pSda}}gfG`loVkVer` zeV|b^-wQI8k>^CwTn|U|yykR-6H0U4VB={{M`%2a9Ra5S_LQ!bk&_Cl@p%b2X=JV6 z9MnKHIZH}6h{nj8?jA)&WX+iea<5OSrV~Ll4X)`-P)&}va96ns^2=#ix*-)|OFv!J zDsocRPLM~P2%GCs{C?&j(Q4ZNi~!3n&%3UZ=vHp#}uGz2GoK~>xo(i>D6f-8Rlb+aoW*% ziiYXru%#-(bZVfb1XQXe5vfzPnZykAScmcMpo$#m%FmYYdFz1=t?nSscEs$g9Tcv| z%=Z6O?I5u`Ic`dtJPxP5wVn##;dRj=6~L=~T{WC8%L9147b&(XKJLMq$xYUx(`(IA z@w{V?!=eQDBoJ0MR0_B8JUP2c*v^UPS?iK3K|Oq#HP;F1mFF_D$I74!@&1&q=#8;~ zrtv+^Y$~b*`BZCRds`!YGB2r0t$c-!sy}+Hy(y(iq)$%=cBG`w-~cGME*~GH!LL*y zO^govf>y8%NWJUC45NOfm*KpnW)bzX6JAxs0a9n|W}1T7pIUFJTBZ#G>YG%}*&v`E z-_)EF1a#NPi3C5>Jt~9)c}FTHsH@0{37#J7^o+&?bxCQN8WYr0j4LKcQ>nn9 zp7Ta!agQyM_q$e5{(7 zf`iKSu*L~>+b1_TaYFYEHdyFNk%*yAFD=0d8Mq#{i%pH*T@V~^^KQcYTk*rT;9K{W;-T?yLQZ>nCaxneMN(vTD< z6j}a&4vg%rBwL3>=94O7N~V-5VyX;hBvG7rWXcMIk}{uCLCN-sf4fw-QAwFfPE@ks zA!`FsNjr_ipoS%77Kx&+6ZtYjVOUaLO3)CN)FSb*lWxYx6kb7n#)(d*YJ^FT?9{xG z2Q*H3tiOFAD()uP+ewZSr!0RuCSgXMGwxue&94x#bSH^PoirM#l1}V;cqA6>bqG+|cqRr*lvF%Ztu-onr(Q^b?60aA2b2aPsJzO!L$rhxz(7;cHeoCkklbkn5xD)M$*PG!^?4PV6hGd%|4NiqSts$Gln5R2Q zLY6oi+h;WJS@xNuNyri(Wt-;&K3xxM^iwLP)?;EyDpnr-)SX=_`YGQj>EBfJQ%yCs zNeqFylO%?z$95+UikgW58wZu$f?ngwFZ+B=6iKa3&BzkNs>*a(*%Z+73Bra+lWUv(xTk_T`kBiEJD36Qk ziBd{+;-clI5KEHaXsT!gN4b|NkB&-ad303kB_Tm4I!a@jBq37klaU+5mcET8PeY`- zP*u}FtNMbF=Y&YhO)*ZY^^*G$CuM&@W1uvZse#f|y);nj!>d`tpBgB&$3K_}i5ZPX zh*1rc>OMv_IW_2($Q>xPRjLpzbtlOw$@c)uazdu%&9HG(dDExjrmPwK1bCDcvvE_Y zmyP#n+*B$?)j17X)rp(39vT94f~OVIBf~Zr#E~JP4qL2*QSIqK z>*&N$-OY$FnCeb*BB~YA#4-+2w5(xOr;<)swY(lN@hV9*HJE6_s*)?J4XbKAMl=bl z+AXGP;!G;vU}zG9tF|_3!HKZClhpTx`socCW|it``8Ld&DnB4TKJCNuFsoKQ6=qFU z&Iz-+3UXqt?j#0WQ%N@JsvlZc)HRij_YOm^?j-RWY77C5X8cumw9*Go{FV132s;Hq z*y2%rz2CGi9<<84A-#BeVdbHo6D?Dy`hb zyZ)D*-t==vr=@wv@OlcAYizP|vG>a2?axUo-!nS%Ih=mb6j8W`VvIl zGVs4T>h%ryEw1l)eGkg@11`Bw@_)qj6R)p|ryllR?8ywKrDcYa8;*Fp*J}sS@M;gr zbq#L+Gg<9T6%?Ddkjfr|OXkG`T5J<`#qUI7T^4ex27j~?@_O* zeMMSY)|I?`pf9=OsJC76%u#QH{#lZFEiQDGUg)kYxzJU5p}Vr=lKaqIS?Dgk&{bJ- zp}X|z3d+@um)Ml+*5Z+`d8>NUbCZ+a^lq+~i=-X6Ug7mBDA$2v^R9QbxA^Wr#yOti zS5J6%XBJ=lxp!5~c(Br>$eRs+G@Ywn-+g!M`^=qH?z`?t^G&ATiDUkC>?sUD7mjZK0XAG4Fv1>+{U?Z|iM3yK%Oeap{~N z$7~*Jo*k6!`)ljNX6EJzBOc%0%gp-j@7=!?bTYFS#KuPNTxRBkN38h$gL!7oy9K2? z@19}iKK{dJkA5`CB+kDy(|^xslPJEw`KgcN!_B&>d=|9tn^m{POqr~3aKK5(^J-7Z!=@83OU^{m?)j&B<@t3MghCf;{!zFE^I zVcH#PW!A(Cx-~qz!K``Xjeh@`i_O|bKMX%HZiQJpwCcqDr47v5l1t_-O@U)^K!V6)NpSm(eCUz?5N=k}>v>0Yz(SpFkF z-|&gql=J$yV^i-kn}&TqC;z2)&8EZIt7ccZ)oiZQvgnbHuba*NuRqdx`b}nY;edB8 zf8}|z#WUf{>Q&pDEw`@x{rgV)&6ZV%D!n=*YPS4*;(|>_cbKi$oVjFr^<1+xQSXX} zZrNhCein~(x^ZR;vn_C2uNJSbHrpmXI;2v~hGyIGIZu7rWwF_Q@%EX|&pyv=fAqB# zYu=n|wm{-oM9On!F8$$|~fn|y!WZ*n?%O#WR>PS5_vnEVO8ztg6THTj#`dxl=J z-{im5HT#p7|2Fx5_o>@uVAK>edAPx$?8i;PO;0s#y=jLjh!3C9YWYp4O~K+Nq3YkY zF$IS=UH#NELrlT9d#?N8vdyNj&P$zpz50zQyyCr{M+dhsh5f(mb5*qgrf~Xi4{YAD z$`lr53~g}pNmKY?-I3FOXlRPOO~(EGY%f!EnQz*_%NLuX?q<&aUVGmZjqb9zzc$DoZzziKnh z>`3f>r{^0lm>v6GJn_QN47202cfSnRy2k9R`o)iH^T(N;fnWbPx9dT(vzPbmq*MQx zos;TT`gP6~X6KeBwFdY`nw@X^E;xQ{r`h?B$+>peFJ@QME|(P5@tIvW_x3j_d?apm zJvQWuxwmdLyOxf*HvQ-C%&sHPbQ+duX?A_TxO-XPep7tT#$H{IuQA0}?H*9_=%=Q5 zz>7n2&uMImXS_RN#g5*lc*hrGYxY=bia+{w^4MQLFuOCoGk=_azS(_won-IOZD#jv zIV)a!Ct-F!mAm2U5y#B#we9k^o>$ZCey#JK3wOnDF}r`er*uZoXUv|92ETmf_m|9` z>qfsdD4AvU44MAHhmj6u&-_K7-SplBv**Bu@Af`XV)lGd{OhIX|7Z4Af8n1+yRR~P zL+@r*xnq>sd(RiuNB&uC_CEdVxnD2*&FtOgZFom4VD`RSr}>Nj8)o+Ym(wQlK zd2VEVy&ufJ&h5;3@x7OteUEp(aq?XcntjXf>H6E>>&(6v2H$z#;?K>#A4m6l=gKB# z|9R5~cKEQb+23~2@ExOyf|Cw(N zWPQH$)1}AFf!4pQz4hwa=D_Wqt)(Zrm;>?JyL?a0FbCE*KA3mWE9Sr(ZC;GmI#}5p z_@nI`<9c6j4mP^wy`TP@WDefY>tvthht0u927UcTyEJn!IqG!VPuiM;ho=3tEk4>D z{A!V>VWU0fP|Xe5&mQ{29Eudz`L}P#9P0BzgCS{;nnP3Gx%i`%1?JH9&s*JWel&;P z`z5%qtd%KAOK&*8WTz=Pr}C=TX1{GpTGooU$n5)zDY@$W%~$*Cn3ArI+KfogH6;U@ z7i~G#)s&2E9r--(VN)_AwEx0kGfm0Lt4)vgTTIE04o7CxK59x{y7|WE%Dy!vA9X)^ zrZC%-oVvSPU_wh%n$iEALATy$N-r3A=jtZ+o6=UpPJHn5WK(LM>|f{b8dKV1+?O}a zJ#0!Jj87dnq5r3*bj++D_Xg5T>Fnh2pS_Ju>6+z#TyngvDc!wpbidWTP3h6CXBRy> z#+07iIq}%FOHJvo2P#*oyVo49d}N0C>;rT7!lSiD7X4|0-hTK0b}HR;&a6{^=+_=| zXGW}~Xt2lhoABEe=lj#m{S#kHyuB^m44Sm|hq;$}%+UBXhb~@!Jlza`?y|0v=cJnv z*CwC3uS>dl;)r)shwABOREJ02Yw~Kk8FS>LjPz+96Tj}p+>M_GFUoqZ1{aNAErT>jLQ!f5`MYVgzo2dgD?i{^;yqUJ9 z$E)8p7;mP3KK;|XMvXV|8BI(6eEEOl&9ejks2Ph+Ff-R)-fTm1f|>Qjy;q(8`vfz4 z?$M3cZYni%{9o-DeOG%k=eXxkQI%3N_tA@9`F2lxlc*bgx52a%61D+^~f`;pSh(W zHVkI?tbA|*5MqpZu8qcS1l?t>&}#Y)OJ{&S>NfWejjw~ zXVx$I=c~taa?JYgvxn6Fv&?L`>inO#zL{q>%xE^UukCl4CXvetglXU1es|{z;AEGiK(Q&DG|tZFzq` zv$@xbOOLe8F`Kt+$?tn^nc4i$-q4vJ^30Z-U)+~`zMt8$^quyBWjSWc_n*G-#$#n> z>s6<29&~e_**fFjw<nwV{uUvQ%B@lVaRr<(WwVDl=o?X|$yk5BAx zwqMl#;W~FWG24f9{$-p0Q?va*ulSQUWv?>%Sv$@SKkYO5t@j-^Cu*Dgo`;{V@zQCN zKlbGtKH722!ZdG~V$bTb9le|PSuU45qD z;nVNuUsc-_EckQD*cPWv!NIe=Z?1dH6nvGHQ}1knDXdxTv#-9JV+td6*X?|7m?`WN zum8}*=en7~DLJjWZTFeN?Ja(4w4}Bve6MxE50g)u!n2{r_6Wc%WH$m?>J(HU3MJZl>tP+pj6D;WI@)_0F96cWtxd`~ffZ`r@?N(QeQ) zmmWK2c04frmOl>^m>sj8to6diIc7(3{P?{2!%VRFOHao7O7Xxi&1+3hd}?m_e$NGO zoH%ao`01y4TcaPCevg%QezN`j=Kf*R-&*ozZ!_rO9z72})6)zM&HQ2L!j@)u(J$M_ zf4jzv@ZT{kadl(!ME-%mnpsQDs5Uvj?fmotGiK}L;unMSP5iR&o_v2w9W(BomKXi{ z{flP8Id_fycR{9^*nP&ytajI87e4n;`x;;4y>aaHs`KX@GE-_d^)|lZUo*99&jBqz zztT*bHT8Mlv!l%P*Y`EQBD~wosQ$y0Yd-niJbO!{uRBc(nwc|h?byRV+{}7)(xzS? z=9}41-~Dvq;gM!e(_eQ*&Ogu0Ir8k6`v&bYa|g6Izgoc{`4gH|dFO$lW_u59wppc>Q7qIUaR{dDi8X3;0N-ScSiD`xT7AD{iR+Jk0E!zl;H z^s8)^9Blkk+Rk-m={H5Wsd(Jd@-#_O6Xxs_2>MHYU!_BSCsu|Vq?fcFcv+BeDomqAEs9Am4y2KZk zHZZG4KiaBAkAY_OtL=`&9~!&YtZ7iK*XE7cX3fC&fBoV3U1rVRwa>QsccWRGJ-pfQ z7Jr(xceOpR10S`uo2uUS`_`s?sYmL0sY%G4H_N}W{nN5|h+&J&(X|w6}%I)9%!xiu2;N`u{)+6z^j&6Htv)OjeiUFs7K4Z2G81!%8 zqMOXN9ntwCZon=)BlGg&Vc(kV-H$#0*V35TzIu7@D_@vuw*NBl_oq(1Z}M}Nyx6z; zJd@vXLf!FAu6Xz{$789y~CKWvZm z6n_`ZFmOFxm2tRcyaSKiJ;>fXdJmxf5Rc#wGkqA3;*T-^aURK^^_YKr}GT|3=PlVS$-x9n8h>wY!)L>K>SBDPtW{cnE9;8e4hOmutG`o0X%1ttk^>O0v54?i|7+r%!)3i zZ(s>4yi|PzakG>aUq)ZSa%n&uUXJB-8mwSTR?vB{k}XduAP- z5$o7P>(nW6gIUj>T2JT1diK}`Iw>}==Qhw;v9Zd1@$1CDvr)Yk&CEu2taFG&H1u7KW>f;h*pfNqll zj%5MeCxsl-Lb_23Ikts#rxbFG3+YxV;#e2ay;8(6FQS{Jh+|&_cZ+yi;ybvGchK#! zgL7dA-7h;hCw9;cvx9SEC*3hSIY)NVEwhtzWhdP;J2_`|(M_|9b7z-z*Wk#_NwkZ8 zn_Zkt#q{44b5a%4k5kOaRZM?QF(+9u{W`lj*>=;vvzwD{H~l=jIr(;%^@O`8KG^Kx zI^LsxpRddwPR2d-|LozU+(SRm9!}1^>JPfx?ByigOTW-wPS(Bj5AEfo-A6ysK2F|! z;xCF%?`ZaM7Vo3uXdh?uemao$b5`$HN74bapR;>E9ZLH-%lFf%VKK=|1&(Je{x|zuWX7Ox4n+4708GjB7oXfNRTo#<* znSUNDFpp>d`K-u%`T!QNLP_fjh?^v9wvbMNMXcc>ItLcBriFwCcuHUL&kM?F8hhQ7MAKN$-+vo+^&LP=8|F*cgL$-5l^63`I=NRSFJ(5qqPrkZI z@=QL5tbpE<0uEgPy(R@5!UB3v3OJMn^r94UNDDi~tvjWVV_QhKN+HL%knWWtj&%{; zEJYmiBD!0OIQB(!yX@c`*g^Np4$g%gbi?ehb0RIRc-!4_{;I=v;y%@%{-p@=d&X7dG=qx z3MJ_SNU~xJ=?hrM3NE5gU@re2SW%{C6jHhMp{b4a$U7o?xr&Y{VtHzc1!l&@Zq zE+(Htl~3-r%1)VvD1$3Jfa4ZYxJ}Kmw7OETNa#P5$Eu=f8kYikE z-73Ys9?Xb0s*fKWMOx!uTlIw^eL~SNe))rc9V3GO>oqs|+mwuO{YVu53_$?@A8#=D z|K?veHDhx9pb!5T3;sbC{4Yev4~0Td{rG1M0)gT$re-|2tU>`#UhOVI{vjj%B}$#- z!seN`RVeEJduOyo=5G}Wl{?Fem492u+MF`7WoGfnmRW^YoY($D)muK9(mr&_&m%wC zvbuff@=)(iuY8a+_h!}4YPhTTuZcB^``(*1s?mATLKE_0@DUhpN;V_W_nO{n(JN{ARgDreSlNZdFKXhNfS=VUZza2f=+?9zogFKPL1i?gj2uorN~G6|O9T1YM;7lS8p zEg_eZ%gE*A3MKksB@^<QO_TwBPkyLgnS;9%DzCpNQw1}?m14rO}<0EOTI_GPyUbmfcy}Y`SB5Xg8Z2L z1m)`uCz;?(s86YXMt)9yL4HYoMSe|w1CGb_EiM_B@5t}TAIKlcpJe>y##6XtJWrE9 zlfRI^lE0C^lYfwZlCmVFd;ccSkpGbXlK+7+9PzVONCzY#T?CEO$kpT;axJ-zTu*KwHZgLN~m)uA0Cl7#edEg)u4v{5fDfkZZ50lT4N66>N7swaMm&ljNSIAe%qvUI{ z{-uD|neYbrCV31*<S z2pJ_~07NKPW3CMT0q$f@Ksayp24;CaR}?wP@a zXUUo5ED$r@Gn<@4&LtD%JaRs{fJ~AL$wlO15G%>EM2YpklnKko<>U%-C7DOAB3F}Z z$hG7;ay_{L#1i&wBsY!F-IEP?+8|0hh zG4d_)IQcgD4*4$m9{E1`Kk@_eLs|b);73e20iJ^XG5HC3k}M-XB|jrSC%+)S1W}mh zEAnfme?xvteuwh4!0*W)$R9y5@DqtjseYRL8I+3tLjFqr2I3jd@8lokpX6WU-(>s@ zg@4F@$^Xc+mR>*%d(m4;4=EXvoXeTPPQOhl9!N|3NilP%b3uLyqs)JwgG*(FPDU@x}OY?K{7;!$p{$*@r*YHb_A~g z<04$igsZ?Cpxl8+j|)o$Nv0M)o9cC+{HdB=1VY`A-brjf9zCFY+F;H;GDWeqXX5*`K_Z z96;Vj-Vd&Y-3Q1A$%n{+aSDUT!Q>Ed9Ugp`e1sfI4g(J$e>n9=$;ZeMoat(>`)N~Away_{L zM7Mi4lAFlQ+)rXY zX#PPkE)O1JLJ3()9wwh7kC4xUvRYmMW%ayBzC^xEzCylA9wlERUq|_B=nW)@!8e(4 zjC>2kjP)KT-zMK7-zDE8-zWb^en5Umeng%iKSudlz$Z*N2|kGe%g9g3&&bcoFUT*+ zuRu&-@7LrvypX&|8Bfb-$b?4VTs+vAdJfryyqIiCHUs7U=41iR?t)3}PN-+#>5=gw9OpLUtv)ff%=p zTgmQZ5Ars$CwV)02YDxm@y@u5yqoMr-XrT@Zs^T~K4f3AAK4#7_h;NoVpvp1?je~Q9bCxIMCjwdI87_W?pJ+T#)ReM3UVcx2a4fU3&=vU2$V^?gWO5(B8$o0LP9 zCL9DWf_{iBAxp`_k3p%>C*(=8jQo`RjQkvw9{Ym)lKcu3 zyI+&vkl%tKq<=?#kMcF)2l7Wy9{hrlq=&?c&~z*%rQ9g@Wr3LSnU%=OWEC=-tZEt0tj2`u zAeKmG4YDR#i>yu7A?uRokmr);k>`^afSX~r9$BAkpp2(wVg=|87)SZ#OJ+l|5!sl` zA)AmFlTAUah|FeWbFu~5lDvexl)Oxc@y~3%# zK0%Hop9Hs|oKa*P%$QCnt~-$w}nX;0w5aGPoU_LQW;8k<%^X zna?m`2Kg*Glbl7)29q#2hn!0$$a&;^asi2F^tpxPB66`3>wgJ^aWK4;Tt+S@SCA{o zJaQGenp{J!CD)PbLG)tg267{KAM{N^$-vu56Sk0BNsN=GqZ^g^ASPC30rf(%h}^;a zo#ZaEnA}b7A@_oDF}RNj`^f|3K@c-I^AK4=mXe3b=g1=@=8Hb}0{J5O68SQS6_NRh zbc_hEB0+lMDES)sI{60qCV7l}i#$%g4UU7IcgT0i_sI9j|B)X^spIef*1i&JR(XQ_ z7{rXv{DeG7mXV*5pOK%FUyxstUy)yv-;m#;eE9)V=6B@xAZBRh59E*JPvj}`H2E|6 z3;8Sg8~HnknV$Iv`6u}o8ULHY8S)?UU-CcltYsD;KO)OYCq1N>%pfyCOwcTOKv;>a zOjfasXJs>?Dp?K0jLxb~)*x$=waD6J9kMQY4tXwl9*C8Zbv}6kSx*^H%c{?W2IPh0 zMPx&=5!sl`0kPDwnvfThP040tbFu~5lDtHS@z1)H373(rK&;)Y%gNSc8#0&lfmqvF zelkD?L9F$x5E&*TWR#47ak=pd2x90;@+$IbvMt$;G-P}78uD7Q19=^JJ$VCpBiT__ zy%c;C6FQMMgVF=Hke$gcWLHq0>qg#6c89ZiInsNOw~;-`+sQk~J5jzqa2FHqCVPQX zVCWvQH`#~mOZFrCllPJX$ot6q$p^qkVD~}tA&kE!3?v7UgUKP}!z3Qo`-hUl$l)Mb zmGvn37&(G`oP2^DNyeX~Fp3;ajsY>gSx=E;NvW`;k0ZyE6Ud3=B=Tu;GKh(ug&W%w1|hmLYaT9ge=g}G{Yw1v_9*uoa1EVl>ynXW>t7f2eA6Pc%RV$&eD$ZrejuTX>=oCP&GbWh^(@W-uO)`A9z* zP^QO{tq0@rScu7CGD1eln9}RZ%}pM8p{-}Cx@{^7z4Xen~PX@@K607Fpj@ei>7!k*wf=fdaTpF6-($Iu*4QtD-`6_7s3R<9oR-rC|3Uvuos7s(iT>`GU zczuCbvR!9%AeN$~kMt|C#@cp9#|48-4v}FpLPkkz&Kp9bj(y^cF8(iSw}wW!^3bTf z_fvPGQ7#RQa%pIkOGBev8XD!&(81+e7JmX+#;5uvg1Wdg)WxNtE-npqacQWFOG91C-gbI0g1Wdg)WxOA+DY9RMO|DP z>f+K+7ng>*xHQzorJ*h^twLR*73vbLP?uF_|yHO7i{1n<9p~xHQzo zrJ*h^4Ry&m=JZPpb#ZB^i%UaYQX2l&Uj+?yapj>dE)8{YX{d`!LtR{&yDs>n!WHsd zb-~|ij4h~Ay_pw(XO;8`J$NIXtz5l1(gREnk|8ooMuhkyp|INTHMZXGLkr6_KU(P0 z&_b7n7P>UF(50b;E)6YoX=tHKLknG6g}V4F)J0x@<#z^Lb@BQG{^Yo((iwq3vTr*T zf{qYU!Gkw*pLWtOfryh6b%a=QXj^#*?=}iPNARnV?oU44wt5TP5p*&_ju3W)hzcHm zFd4s33c_|{+{M?ig%g+GgnZY%i6>HHA7&84B+TpGH~rJ>tg8oJHVP#iWA zS4p|DF|h)+5>~)o!V1_-SOL2UD`0nG1vDro6Dgd0Bqr?$M>PQg`UyGsE7<5KE1;jO zfPS(HU&Lp1;=oNh9iz)Y*)f!7yA`UAL%CpWRMIAJ^pC&Y)EPtjW9h*(q4@A zuw^;vmjYsFzZKAaE1>;WK>Hzh{P@EA#b^xMGn<1Qv=z{?A_TB?p+LidTpAAK(r_S` zh6A~wWPYwb6?TM(BScm31agzxb5UjhyA*pbwkZ_+ju3E!pd*BmjoXM}Y*r{l93kom zF$(_N1+C;>zmN2j0ig#A=|uj{vZWLp zz^>N{=vOPCU#)s&* z;Rp>!9m7#;I5QBH<5^z6?4}t}Ii6Wbj(}E@BcPS!2xuia0$NFqfL4+tpi1~cJCYm$ zZCa`fe3hNFR2i{U8L@C5e{xQL)CFH*M~bGTn3XP;zlaNQ{Jq&C`pQLrxfm!HgXLnV zT$G|{LCT^ig;A8!tmrE*&F7Tn#UI5^b{U1C3HoqqwF1tYRtPyl*byR*5OstY1)L@1 zDNoR!>^usCAH-q8n!z`Vf@9e47{=R~S&m`64VhvM;|~PN7qg5X7yPxf3YvVq%k$*x zU9QR3yIhm6cey5C?{ZDP-sKuTL*qY4m4~l)xfVoSTpH@)(oh$dhPt>k)WxNtE-npq zacQWFOG8~wpK$6DL|w`?Idix))WxNtE-npqacQWFOG8~;8tUTGP#2e0p)R2cb&)ei z`JLekbqQCfOSnQ^f+K+7ng>* zxHQzorJ*h^4Rvv8sEbQOU0hm)y2zQs$@2#BvNCh4VTs`MIJX*>2z(fl00G|vE8u%z z1$+;zfbW47@I9~sz6UD6mqEcAmecFpYAw9@hr2XGTt$awNkMRDl+2QXVsHXk0bU?0 zL>&Q+AV~>fUqAt#C7S}*k`>@vf*`&pH5|gWKoT-S;?XF0i6a@39luLM54kk-P`QSe zl3T-Qx$-btE)ApQ(lA<%<_*DX*ma529h(RW5l4U%&St?2rvlzoB4pqXTKAE^XxbDK zN}_~PD4_(A@E0ce$qV6irQgSppP$kYURSegVq*}(hRX`r1yS%hf?ov>zR|O4VmA@O zet@@x93kuo5l3(g!((A@#?SoMw6~x?tbqQo z0{TM*3?>EmC2fjh7*%G9HSEPd(w01Rk(3zSS4|3x5rA+MH$JLixuydz?eT7ZI zzQPLFS6Bi23M-(Kt$?@Tlqy3OsZGPiAz5plr)fsmhcYOk3`!`263U>2GAN-8 zN+^R8%CM3g(kZ3NkY&lVR2kxvWE#rA-(^Kz{3wGG%AkZYD4`51$yS0A%AkZYD4`5W zD1#Epz~8S&8RBE4gfb|h3`!`&O0q?ugfb|h3`!`263U>IDkGRGBbX{9m?}d)|GvRe z7y0y4l6KfMX@`}h9acga_{-Vy1j?X^1|^h131v`18I)3GL{epl3y`^~G9oAge=`|%kxwus zltBq)P(m4$PzEKGK?!A0LK&1$2BlOP;?A>a;>x3xDnng(T9;U=3>+4cr^ibDa9D68 zl)*HVK?!B36p?jK31v`18I;ftN+^SpQ$|ES&P;R4z+atBrKQS{b#CvIbxtW&hA&ly zFI9#QWt7Fy4*YAQ_#n%hA>umxh@T5yEK$vuE~4A(Yz6a{Kox^ zZ$t#&Y!Nad!3s6NKg^oC8+jFKAa4c767nk4K;8~c9*pAy3F97o^Ws0_D-(gEz!ocx z0xectbU0?XWm&g|VqJM?c)2Do4wr@jaA_C>mxj8yG}OhV zp)M}1LR}>O;L58|7l}WV=jmA>)dq<_xbiC0B~qa-kqUK*pf1Op6JbPNJT47&acQW_ zurHiGlb2ArCNCnFhPt>k)WxNtE-npqacQWFqj@9PdK}t;!+Qi<4+?OV*c9yjRlwGR z0(>Pl1x^?%zzJi8pbCh%CJ*kw;XQ(Lg5+dGG>(vJQB0;=xh50d(W3H#ax`yL;-O+X z3ZJ3~nbBPFWen>BXGau!k(4OD45o@NgQEB{D2gwGqWChbh&NSA6ki5Y#dAWjyfnP6 z)LDaq@w!ThbOcE%JwYPU6(k~kK@joIavsB(AtllsBsYjZsGzU3O@DWAdZ>z08bv8h zL@)k)xAkg8adr@gmnZ7CUM>8ob>;-ndEyF-!l6k4BV|)CQdWRNR=jRec-tt@4;RJn z4ww>C!Gq)F_B-)Dh~hP5bMP9X0EeuaK}>*xV;E-#bGMWb#1YgAID%RMM^F{SC20j5 zL9O6-1RO$b3J$jrJlHU|yIX334Lx%l!=dPcK2lOBW*N>UeWafZkU=s;hJ_w1hqJw< zgfQ)iufM+-7GJ*=;On;neEn8{uipyr^;-eHek+8ND+lP~5l4tRLW}~A3@7iCdvLn9 zH)A|01RNpg2=F7@o8d>c0{qBUfFBuxCyE&TebNT3Tbm<(f4xQg{#Jl{-U{fzfl_!3 zBO^i#hj$7X2b+R%fZ&0>b^~EJhBG^JaK5m&;Cx{PoG+|^gNq9Ayh^QDYd}4+vdQZPr)%9b_~OxpFc(l4~G^!r3{l1GD^lQBe|rH^b0*W znrh2jT2)*yb-qXzMl9!q$d#z_eXlu>}ENmHoyBhvhmYWIHnKpivNnPU6UcgK9|!N~t#*u^Oz214kCp-~VI1XP?pj z?X{nG@BQp&ul=!}{j8UjTpmYJ0E`ZV*q;vt44%p#Ev8$5Jb3anmv1nB=ZGly(lF1l@jwCy~ zOg;at`W@}*$BLi*$Z?w3xuJ0dIz=ROiU6G=Kz|F+D-29r1$qUNon6jy-BQLnNq0-t z)KR(svrB;4CBWk;frqH?4`h5&1Z0INBJ-dqP*%>g=<``9nk5NO@^UsJ{` z6AOm}M+3(LCj+Miv@X9w>jXOH`@Pqcv6SwY${3S%0j-M!tqY)a0kkfF))|=U3aB#@ z9eI4}m&%x#?v4Ld#^_xE({&`6t^@7GdpaDVUc9FTqd^PC0P6|$>pjkUNImw@J9o@I z&3Njedu+E0?Ztb?>Baid>#zDp(}_{LbYhl^h3UlTT_uw-E9PX(!nR2m+ffFchfc;! zc}Zc)D@?}dT_uw->y%1HJ=o`^>+76|m4WHCVD;c+tF^-?TuFHFwq5DQLpvN1p>HF$ zW)NC22(1@{RtrLF1)-IKqpQ{lA7Rz+IjZXH(6n#=hQ{P?X9k$>BjKG@fC)dqgdbqS zH=t<+RuV{dnBrdg4K2UV6gPr5|A%^8#UA8b5E?@u1tXAt5lFo_&MoaCka7`7w+Idt za8$y%a3BN)LE6s0&v`8O@O?I4g?9dZv?>yIU+(;zt#aqzAFa}XtX`r4fa9sD-6pl$ zq;{Ls?l84OlX72&y-_qNO@JmPGv=?t)ROt@h5u74^A@APjB5#+RG3;GwU%ho_y3DZ z9cfx5I81Pq;5dONE)qR&`S>@p6`^M>o##Te_$0zp1svyQ zTID#mW>pS-?q6A9370R8BtJE+Y8 zdh+c%^dl6dz>|)I#c_Z~9Y9$Ej1+hJR}4V`hM)iwX#i`00c9yLMMuIE9bj++bdu`D zJ5?RlgH4%?v0uz3x8CAQ7%1MNvbl!>^JpaOSOY9p0xVVn3_$^gpa4Sf{yE0rrbRmsba`G8vyHV;$eWd>@x^ zZ0hEf`>5=OO-_M%DH0~8K=b8C&UeGqAOkav4I(`fEq`_xD#O90d{yJ_WA=VT&H^;R8czJ6X4)UfP=CDUaT2Vx&m+3BH_(i zfFmt{j`=+OpfYAEx%Us1Fb_bOwK3yEQ(6OFdS5+JI?Uk$k5p!|i_~!1eB_{)?1r#nx7&{94 z1I+ULTqk~#F&dZrwC8fh+H(b1J_MNM1)S;`VEGUU%ZETS<|#O1&ht!4Gd^O1>$T1J zh*f1IvUNBcO>k-f4)P47DUi@9k~BH9tM0Fov%V6&dPs8}@j>qHp|U~c3N%F|G)3TG zU^8$ya5TW^bL4y&eFBU=26V2#s1^yMT7Xe4z|0X~TmyF4wA?sS1=*O5;OxW#M#~eG z#6(wM?H38daDZVrz%U$O7!I(i3@{D@Y>RFtV`jQnPL(l=SK#4A!ov&j@B*y;0<>{} zHV)9n02{5Fw@y`Ky3i-zuZ(%*1zI8!S|UJ81Zar>EfHXZ56~3A4y()??^ni0r_cS7 z^2N5FaIfKh!-IyKhKCK08Xha$L8IS%MERj`&pxUQQMdwAawJU20jA^ttDXRJa)3EG zz?=;1V3v92QDuyk&^Gn*HD%0#^6MWU z<6{)Az@8`)7JdQtL;>tF0X9VeHbnt8MSwnge(?ije2l_f`(tH{!WGyaM#7u902|K$ z8_xh6&j6F$!+fTU0ZAcNlGh*Rvt+c*V$E+##-fj25_)hT^w>Z+88W%$0xK{H)?Y#o z41^vRuw!^wAZ&*0|0v)g%pDFqAUwn;uo^Nx*HJI-+-_V2S83N&CmG4VT<)SpbP4B;PKn9VB5uwfU3$0V~9}+8LejD1G=Ml zAMj<2c=>^byb@zxi9xT#s8`w+!6JQR+aeh7&MrMkS)4`qke?7kA3h0G7GvKKi@M5K z)s86E%3`P-j?lI+pIAfE;X zdo`d<*#O|)Kw!TH0y{Q%atAHIv%z%)c5R>(`!*2RxdFiNh<5{l-5Ut(-#}mo2V`Rp z2V}!~q}STVfiAI=1A)C92<+y7-n7T~$ko@i2T16Ai96ftScUPMaJF@GAVq)Qxu1iH za#%`E5GKlLqBY8KqHWZ^4sLvk5>fAj`wf}dkuxNI;!}5>=}khCnbdqac6x`HGaQ~K zM426D$V}Mm7%~;#`Z{Rc#@WF{IrJqT1{38*)+jf!M!AtCs?&&Tly^aElovv4l(#}_ zlvhJ*l+#~p^kS{X@j)v&o(~+g>w~MGrac)067nR8vm<=?)3hVjgNQc`=^nnE-rtB|wOUiD)f%N%Ym{28QEIhDFV<@OBTPXTYc(Dc znmR5LCVH_}<0N5Hsg*n-Oq5!!QEIhDsg+z6%*C|T8l_fil(ssLZk;9MxBGmxc_Edy zS}&$nYm{28QEIhDFVt#(d?rjmYpv=vfq7%!ZW9dho4{-n#|ezs@toi!xlS<1cY;CA z6Abd6z;bHqKB2{p|Aa<4|7fQL6XmYu!(gJ^^%~`_*C=cAiM@_Pdme_lh*nB}d zSL|2eI@e_Wc+24Y0Ee;o) zF|9}3fWPEDr8R$PLitzgM2j@ zd=ZQO67652{Y$ie2pzvxVy_N)uZ8Od zWyktx64_k$GPdg_UKE$u7MFNcT*4R-Ld%Cz1UbivgDQ&YnD0wXcDG>i$EPNLeQLsl z+UxAf!7@e?WIJpCapu5aRBsMSi#rF?wgk*p%_ANioJuG9@ZBal5kvzV-F)~vEb|W7 z99{hmTMIdLD6oKxguOt3HDrKAWPnvJZXt{*aH?JJqM_P1SIQ(dDx)opYU0dG!99A_wPi(r9M8AlO^F#q1?3b4W%!u*SjV(mvl#m13@ ziq#R1{(#mh(OMxM{SX%B%C<#t8zV~*|DY!9tJXsuzLv=!4jvJvBnwN77-T{`YHBbTtVok zb~2%##><2gStXMw8LQ-y9ZguqDmgM%J45z0p;V56jBHzk-A$+n?7)-At%L4q4F6JMz$@2Ez8JK1iioBC+PjWsGi<`Bx6Vv zVH{BSf~|Ut3kpjaT<2N_hCv3^K?a0D27{so0^uE){`YQv?`?NK>G#)#gOPB)Hc6Z^ z4{(+>a6E7_aBA3Ljr{L#yZbsXvL|EKI{6W6okB9k;RMykL4@w4z9)=Sf234@km?s@ zu^6PW1{uEwX{`Wq0;J* z!gyX3ZIIFi zDJ{rr_H*RkMoMXe+}j|f4RUXT+tQA;h8XF#G~T>#r5Y}J!QOdk@?100^U~_mg1b1b zQwt-d-S(%tH@meMq_jawE6PebNNIzVHb`lM+}j}cHh5l|99)d_yfnGEs8nOg;CX4| zD5bAaYOqGB#Tun1OH^acHahMum{RKRg4NU3;YAA{j~5fY zSeNm6F{u~pGF~s7I&LqR=i>K*dG45_h4{Nr1>*Ta6&TkS&2xNTO!Q&}4)rMT95JbS z97|M>WQpproJTb{tx-LmB~=|_iKiqTZPd|Fef)f%O()+n`F zqqNmFYTp=7e~<-&d}9<&22KmCkdlN=x3E9JF;4%SuR;X!jq!IMWPu>x7!sWO#%SHg zImSe#A=~@jy2o&;{bM+L`Nt5{KgQ?(fw3n3F^Vz^6=fDG+OKG?m074#nT3Kj3l(J+ zD#{2|lo6^}YZnFEKL+M5VQp%{8r6igstIdW0~z^jITO~fCah&mDAU?syr6u2R_60x zG|GTiRB1x{$FPBr#jp*8Cm4-v7nFaDLM@N-k5Nf2k0)%8D&dTlZJBkD!B}vD&2eOQ zkztvAWH5NdNd|*Qy<{jcZZb@m#*-cIc!st`#8rl`V}t(Z8hB3F+z+uqk4)y@5*zfA z9cJhk?2bl;iJ4R?WuFVG@Qh{n~(V-y}K##?xw`Mn-cGCO1!%%@$RO?m)RdrF7~9MoOyXOGW*hy zj7<@aEll>NVX`|76Nkc+3(sl@D}R51mA{0Qzl4<^;?C?QLu zMl1i7tHNoRP@QW~l~c5KWIQykBVX_AflU;C#FkJLH z3>QQ8!r@f<1-VdTY|(!syHg!;IB{D9h6_A!SjG$95@*jtGF<$vQ}roW3ByGR!$k?h zMTw(vB}_>rj3XtCBM_CcTMktU!$lK$!8)`pBCa`9JzmY=O2Z^y8U{JjFdPraKZhl9 z&>^sg4uf2D804cvRj`u|RUuwFoHkk8PlqL#{yvl6*`bDInEoO|HHR?$Rfg%Wgz2xu z!M+maMTp|E1Ztu*`ltOqfI}O9`_}iAV6c zM)acnF_kSz!Mi0UkkshaBJ;2YAE*o-kmy9iL+nu*;`oO>x%bhYm-AWuh<{ z^A@HO*IXC7;sV!O;A#sn7JXI~)EiYm{yQ#zR%K$DND7vTRhz*us^EFGs z7F|hf&=uI83!u8WhGV}48*`P!u!d>c{yPdbM@wRBw7|w_fo;(Oo1y`|O7+jtSAjkg z$JEVD=sjvunBxMIv1ZXorpnBrsh19z`nFKh!c>_BekC?PQ@B2W{-WxR^{`3P7+CBo znVfa5)H$P_`4!4ppqam2{M0ZwiM`uP9qSE-#1AIpn;H~AOo7PAEm*pXnr4q(0xZ~`EJ_1b{$71#tLkr$7rzoFJg_g?s>GG+~1U@DG; zX)?e>9AF*}Fbx~fy#kXk5}mz${+r5}mFu^^rHoO%0;(4Ysuw`@0;pa9)ia=a1(X_z zym-9yEoF@6z4C9$Sl>zqSnvf{?*-bA<;BCDUS2!`Xr4fyQQ&r&{Ls9nv>VHdhx@9$ zcof==<;9~CKK!C>PcOJ?pZPA&OKv<0blphkx&gXwfUX;$>l#qC0$mr0 zK5TjVyF56#@fg9I|4MZVFXez0_oRvx$$ry?II@SA~;YWHy+A`S7>Mm z()NBG0(2Lb8;?SJ|Gw6sQiFXhLDl;?#pm8HHy%x?TJ3LAJKT7vOx$=lNbPXrp%`vF z9L$aKqRTgmDy0cfrR2&iR+w5ci(UJHs=`-`1twlgP^H4ulG7N{(S20uh36<3O=5Z@ z#21CbqlS2*aNP43>7Kr>>ysvCuj_K*@gRwwO;G zqB;pZ%U+lFOT}^Y@x3pSJv+N3A3pbE-62jr5*{}^X?U8DQ+ZCusYgQ8JmU* z0(^8BKo0}xVE{c0@HwO4Kob?952LQWO7rO;UQ=ktpZO9VP=E&%-~k2bMgcPZxi2PT z1Bz2X!y_T*096i96pLWg7BN@!U?<`qly zkEy>^Ezq*E6R%K5;uY#d zyh0s_S9sD;e@{pp14=?2v-f#8{+>|h;nHBn&c<_@Ia+J|{xqyhXTQg)@=m5@s?Esc?y0xdj+x+<Ce}B)VGrV`qv(t$UKX8_Sh3OPnT`F;> zVCm*QK}b71K)vP0qd+@ELOTR#hXCympdA7}a;%@z5J=?4<7rMD+l@yqLEQ>$_BlRn zHy#C_%9g~3vIRbqE%1?Sflp)u%xJIp=U6@pjERvjCIWKf!C&-IxDS%+H#$eIP{+s> z>J+&`9U>?68FGa>LatCJ$Q9~nI{C3Oe6R9D-8j##1o~KjJ{F*l1?ap6)Q#ivT+BpP z@S%E1e5PLDBlQAa8{}f2*_VVS*!RzAf`C5?APIeogjO#2qXQ+;1il!BE6}(|Vt{!uz`Ph>UIgT_gMaCyfPB$G$!Hm$mH=p3fd+_#1_;mq0WyBn z7n5;-i~}rd9&?gE>QRQQmn=ce3apnRVZ8*%XUC04RUPy!*=Vcf{It~yuto^b76IBq zAm<$g+9DF#0@z`YbH*Hnnv`aI#D=TaHsd3#rtfG>xz0b#}_%(*tN)BxqW}-_k3|pVABbCB48O>kIrHy?_qs4(;WrY7-vIWy0OK!U zuN`M9fhn#jSR+295>UAU)`&Fg33iSEb`C)MD?VMP1bP#ni*qec zzd%z&LQ@22iU3U!peX_jlmXfTkoyikSSMrLcYIj+V)##}ugMkPZ+Osf)9|pNK2g_o z`a+%j{DC_8p>tP0q6BoVz+4;&b8&#VIKYA@z(5&bpbRij0&?GR`6H?*DtGNEWsJ%d zFbhY*i?je!MF6{S0K0GiyKsPgFQBdIV^1k#tQ#Nw7#YibM*&@q1YHiW_X+UzUx3X| zfXz>UQ3B9j_oc7zfM@o|C9EVoGD55*w;s8K zmBfP@1`3a9gdQIVJv?0J|Ct#bux(6!C>okex;2>43QXvcfzShkEFHN{`!ik7HjiS@ guyQ!?h;WAY4#!-zGq&@o>cPpkp8dq7kH7Q(0a1&3vH$=8 delta 87924 zcmaf*2Y6Lg)9-U~P70k+l^%L0z0jNh(t8iR2`Gwy3W&f-=pZc|;Lu4RK!A|m6G9qA zP-%)FNL56XDu{sKotgbV!Ta6kx!?P|%isC$z1Qru)~vP5>|bK|wPJeLn#`_*wW zb$7CPxu&_cdCSSXwT|r%*LAKnS2~$51lbn3Ezqrh7THR>uPa$I#>vw1ij$L51=~(b zRofBwrLJxII$3%yO72;rz}b1}cee7S$2l*(X#2GEM`o9XU2Q*?PI4XJm@AaGg_o>o zi!Za)dBH_n&$1JpcP+D}l>N-?_Re)%^Kwg^=d88eDOKBczT8shE$+4v<+Ggk7un8~ zsBZK1IOY6R+jSLYI)6pB*%i`Cc3JD>e(@hQdBdZktw+V3F1)Eko#Y1eLmFn_`?JdtfE-RhNOub_J(9_TC8{E?FJ+x#^+ZZb8+%ni6(cQI%Ev!Kai+8Z7 z4X)K~V;Yro=A%q`ZZ&KV8|&{!Nqp3qrX{qxXD;s$5hzE=p0zDYn7O_^B!~Bi@MqzX zh&{n_*lyPv>wHi@fp=W@Rm0)&{5!IqQGI$8gjA1+gOKXsku1D|jrviCAmscJJ6Swz zYZx%ChY$lHqgY5U`L}5Y|IYI?>h~K7A@x1Bvq*T?s6TcDgw*%k1|bcYKAc5ZgObMh zZRJrCp$*ugf(KAW;6|uJi3w9_H#txSm(`=8*ykfo@GNQUGy4Pv+itvTIKkIDNZq5g zTzvh5*e8jbT&t-O-(cPuQoW>M($AL_`v@wK6?;j&XBI2$B}1?g@sc6bL=GwihzWL+ zVIn|GOizFc6dPlAIg}V-Ul~URiWPR2p@PH;dkadeu)C_u)X|2py9^;V`mKi$6OVSV z;E81M5)|Lj5K}Y^dAhIDZ{hahodtz?Sx?d%XNvx%dYMva4=%XIF^~@D-_^lVbw{ z`B?Rws6cO4>N!Hu~*$D6yfg(|uw?UB^q2 z$Cj14PL)_u*NO5LE9yE`+7j^=E0eb^aZxS#W$_UU>Nr(mK|Qy&B|DgfI!=VtSHFpn zMyT7QlAoARx2e)bh@(XLi;eu@4kbpy#cjGztf<>W$*3A`Qzcf^ZFRhihN#;_h>d)4 zln8BzEIp|d`e5+Me} zQBp?-Qv9Ss42YXV$SA6pRA>t}V~@5#u8@4iH^xxCq)JTm6E}(S_V$OHSh;xn`#apE zGFYU#DbJsWQVx~tpol;gA<3}fD^~L5Iw&@M*^0W!P;5l~q{>f>=;D$i{ltncE>Zqs zMHiPUv2s?fgsQ|!zFY|->lrN(cc~B?;x0WdP;5Msr6sij#fCV{P+~)um+T9YmL%G+ zFGyP=mqOVWtfL~ALRDgAtawe8SW&lm1sg3WMze^5-aLERl$Dn9V-_U*QpXC`EnCeB~}vUCMGIKtf=c$i4}F7 zs9>?8zEdSu)Oo7JiaPIMTOL{#{q&Z`LTrSHBl!u0hnAJPPL zO=|gy4RxC;v7vrbB{tM=qWr{&w_G|^i4{+|bc*uVmWba}i52ymDzTzVPE>$cQNO7Y zE9y5pn}8-JJ8q{Bv#mgh6)xd>_8}O%MOPUE00F1;`_dr zm`U7TEX5AHP-^mC{-65LA;l6q(ILeYdl6Cw+3x*D>hKJ6?3F=wIFc{EWA2f>;vbRYOL$Qi+r!CHq#Vfi}I{x%j?ZsE}D4R z^N)xah7qY3te`6i3Ka)O~YT3PUzXzT2KMe(i0Xlnx3;uT=*dZ-7= zyD)cST{nviv$1Dw7+2C)X6ayG-o*~7VVl;iwDDFwty>9m0Jof%opjseWlx-Ms-?ed zW4p=^i z*Yzl==Q^v~_=@7i2gv)29PKAnAA|+eJnWw|(Ae^0Rr?*9mL!_u-jt+-P{#dM`0% zttG&VH|ryW*b4Atr7y{`OpMr7ZTW~r}lWs!Z$7!M?JOpw&)nQrtfNa`E+K-nkt z!{r%Njtmw9dbw2Tq#RkS#0p1guurTQ&%FJOR_N8;tA8nHIZUqmV!}r| zQmn*8qTIiApP115g(zQXh`!FMl7{dyFpl&SEBf9m`}}k`$Vl6LR~8T-VF zzUj+8V^|&gg2jpv6X=3r)u$`I*6;-7eS8Dpw`WmeMepYi2WcZ^(bygi;#J8z^tLaD z>9ESG(MmpILf@uzpP2BF=RZ+8th$6$i4~3^%04wOONf8-Jm(#{ghc3o$eNKlI;8s0 zqDn02Yr~l#YC+e}nIVP+T|OdoFyt*!>gbRfulZg0nU^hS9JHG3bdfQ2gakx#L$Hi= zFB?MCN2ClZ))7m7UG~wy-k8u*&c^+oA9_Q%DJ(qY-AP1{@mwIHgw3OWBNu*w=S{kT zcoUB$D_ugWq^>?8s*=h#!l~~bGoTxytqDx7YSka{q^=IJt|{HCV|+u_o*{L3 zWK|hbOzE;xsl%-6%8=43BZMZFb)faBR`>ep7|BDfA;lEd79Xr*ZG`5euD_Vl)ujjP zXd7WX*&Cn(WvoPzI#R|OW2pnq4{}DW%_hk%7jr8>>&Gn9>Dj>=jeG=2Ysi>-&Wvb*zka$8~ksvGCko1AW+3@yZj;wu+Y? zYZ-X`ULh+}G+QfPe5_^Yi&r0;*Rj_Ct)AR3$nnyo(%*-r#w-jOz>=TojPVN$@M5X= zG~FBE$5P+LSegRu5j*smj876MW^_U7fq`O1SER}yF{4Y;kYYx|&W4m0>7u0J?)J62 zO?7NxQ%czDU18(0#VeY((C`xWLf(>0!xI|VB0U@O)68jalc#OWk`lH@o(;_Y{6ung zE>}6ToF7r@HsJl`e0jgf2$k_7>#QkhyIHqB@9pEqGIBu)n|HkiuKuI_qe z;IS(E1Vbh^XyC@}_m-QQ&U87()KIFdX^mt0sch8-GD_uXLzc8XZdhL|sIQGH;S%GT z$_?Vn#u9$$ZpULIb|V^TQ`*7M4V8V`LwYyXrs%@ad*Q>Sd{36yEK81sece0!M9x2K z=Nii}wj$K@Y$A3~i{vpkd-?h5RiA(J{gOSb(@2!J%oS}UE4xPr_{^iJwyT3t-!@id zpN=Z|#wt@rE=^*=Pv(0ZPg~4C%>fcPl4T$!gS=Qd8f=SbuI=mslQ&fM>B@5LDtT<+V~xwPC_h%(Y~2^c z%D95^K5rjZ#^c7S61KA~w4vSAOi5eamNK@d4Jr3Dv7=XvRq_xk!9#5}o8`xEe{Hv% z!p~2FmAZb}s7EVpYEPqWwy`Sv^kT`&z$}OA9Y;hEi{fSn`mic)c3=Rj;${bVv2rxq z?%jvI$0xQ$dC9!-4VIen_^*QzEH(9^gx47l4J+*gD;F<5JvzbC>=hIsomdyakEt91 zmoD&cds081Y_dpic#C~MA3uq(%fqf%^a*06(F;+&Qc*jkDu9*tNR*!!EA5dgv7$X< zW%nM)ec&H9PhUNUztq%w$n|wR_gQF%L`XgDj|e$Ax>M4^=PvF|N#}q-^@yA+$csP1 zs7K@!WBv3LK|%7(MxOlTkYFEH#hnTckgqoKFwWNz7k@9Qk6wxNV~K8w6hr72OK-7+ zj=9?+{TuR_`TK|ky`QQH1vbgsFK0z#td(WXfsq5%Hf0JTa>~emV zVp;6+06#G$y-z-4OW5v6WTu;*-$Y$tw-?ftjhm357vG-g%{wJHElOvnKXqXG+# zQ)>N39uS&};1JRPkMg|7k$Yu~D9K;Ib zXE1M*;RQ!JgF1yLJ$1apW|-IfBE)Jo)%lP3`fwI9BX1b)+M)!4UEh zpB-ih`G(Jrv_>UOZ19Y9C^2zk2b3l@JlgJ1Vuamh)YHTU_M4$JvB7hzLx~mdEvy`g z4I!H$#Kzfh2u&skVO}c8 zuPF}dL{*X(piUH}DGusHRcb~2#>(Vvk9ub6EI*AL2lb&UO)U^7I&vJ;hmITvb)h52 zK|LsyG{-?bs7g#kiO)o7jzeO3hmuz0iwAX|<~WE4MQM)14e_8Vv7)Q+KRFH^HLXEy zl;qf?I3QGJ(}%sgT1Cg42ai6Xtu+2UU(|RK)9?sN47(REIUWGgZj*o?I13bIy$7{ zF%>!j>@X3U?I8YAAzg^#1*bw=AZtv%&+8cSZ4ydNh{I%`BijMv&zq3)pbk^XU*?1D z>ahQ$JajBhc}SECq?mG~JV42Z`LpaRW1oE9=l6U=Y085xHmRp654zYyY085xHdSIJ zioK*({58=)u91$E2l1H-O?i+jq}0-s2XUIA#D;jyP+~(@n;fYr4-vB3REd?ba>*2> zDG%Z~Lx~l2o$eDW>N`iugZj>q@}SF2zTfNc>T*-1He|V}QX8_|L}|){_|H(%l0~o|%K#3Jyak@{x?iXJ&c@y#;qU1iOlE2S$FykJ}|KvS%EY5pS2mUAT!8nV4omc^ zI`ST(#DOBjM!4Sb_|w1UJ*fZW)4#XaQ2(hC8|pt%n)jgoQzcf^f1)(+K^>?{t;hva zm0Ho~6y!aGivt~b4-w)&IZpE))PJhPhWbyH*w6(i%8~b=^^o@v@qoRES!6>d1RAPN{hh>OI*PB;V;d9LCQi$a_%lIr1JNWbrxj9;QdKaO6Fx>l}Fx>N)w) zuXzvZIaQJ@kSLy0CD{h*IZ>MT5H6lmCC!MCwI@pR9@KTJ#ESY(l~_^VIr1LVb&k9T z^_(21c@OG2RbnGVu9~XEMnAdLiPF4>vEn&Z(vs=oIaZSQ(96wxG-ox*S;cE|j4`14 znDQp=fu9_Z_Ap&8nsS^Y?LigN9@J;N(p^4Z>z_Q1~^tn|~o z`b?F4nxC%EBeG9F&C4azk@lcYbEG|})1;QBJ*d}Ii4Ap|DzTw%6QyYnW5sQ%B-LQL zTrovy+Jm}Hm0A(EsZuMl;zViMgSt(XSW&l$(zFNln<}y5DVI!DV#QnTcA_-xK^><` ztf=EeY1)H2PL+;|I8K$0imtihw1+Zo@(7Q#hkm7@9BB{6K23XI2STZp5{5$B13NH8 z%pmQ79cV}+?SUPr(nx#gmj^?Rv@RWFWY?93*`lnzt~E~ zLofbj?jsowz3eUL@|XTydV6)GJCxxUQKUQcv`y{eYWKTr>h9_@T0iEWEz5i5OPYkJ zxfA>X99qI2KG)R8k@C>dwuVzA94QZ~H06QELu$GkDGz*CQDu{q2Oc?Nm!>@2fRdC4 z9%5sUrabU-y-}$z?_y_k(v$~&^p_t-$^$RCPLf}sDG!~EUnZ+bei=Cr`Y_5uKjq8f zB^1fM|^q{}_dLkJFp7NZ`N9#DrT|kA5 zlU!+7a1_-$T${qb!i``20gn%m3zHnJSr0tr4Ix$a5uNvF)&s{lWRE@ngt}1E9(qY@ zgCu7`A3Pjs4|0VRi;lDhLj>?){LPlH*1dT+G~c3Fi3z>r>OMKQhdjZGa-=;#i4_e7 zaJqy2hCjcq{U`4M56q6_2ff_04J1F9jDBWk~r*!}hedSgfagDjuo{0F`N%V9dKvVOFZ z4y(Re={{|UJo<^!Vb!&yO1h&#tT*`&a-5O9plivI|DcbRQb&hWmy#;6pwFLg@*ns~ z>P`NGA*2m_Gd0@a$bWFW{TC-eaQL)?v=T`Wx|~$<$YMFEWNX28BeqbS1fffb_ev6k z5f6Nm1;LNNZ?Yf^A)k%)IZrO|W7qK_GtwY*AxSELek(S~twWW3b=KviN@{D6M3jD? z*X5*2J~``h5~W|~bvdaLE4rLiX&Yp5iPBH=x|~#r6@8x+r61-^^1Q1`+fuBwEe@q$ z<#k2Lk@{_sZ!$(b{U)zZ)Ur=M$?J+zC06)WV;rd;pQw3#gr~CLy9R~T`F~$b$J<5TBYktr4F<{ z%6W^7L9%&kcE;6mFqiuxxiqjyl(zvdsL13w|)B)G0a;>W) zu5nuMSVR-NQM$gpGCiIfiNx|4$gy`+Pj24U3Y z$8+iL8!2Oj<;Mr>uyYzj@%rOj1|t^&3s5v0MEr+O;K+sGuN|^LMYGA`HOSh?g}@@@ zb2xG#-kgKC$p>S-vuT?(A;O3uN*Da)!?P|)-Kz-^dXqCG5+byNMnXg%Btz)3)Ppn` zLf55AO@`2gX-F|)1Ult>LE0L*?{VrwIwwP{?P(A5HuaXT!QQ4mjM_e?K8|dMUaXI> zW^l5DV6*|wbrAKh0Zw%gwUgnH?BLV`n2 zY0EoWf%6-*Ee1HfL59$Wvm1=dx#S0EdV@|1QJUVM?PDeB4cep*Mw1NuYk-p*q%A(a zGROFn7vGc|$qjmeQ6c|% zZnow&6gOLQ8;YB)xedk5=G+Exowbi)Q&Sr>2qKNq)CRrq$rpT0ZO~4zLTZC{f~BN3 zXeS)G4blbVHpo2tx1ZWKQX4exAQm;XK_5v)X=;P^N0lTfXoo~;YJ+x2m82+WhgeB! zgLYw{aSF|B(A$C|vqAgg$ZXK=I5Hd18)P=1Gm_b0I7H5+sSWB7IhSdOsTa=@&H~_X zHTrNN$7pUtaj!JD0lnf+^_ts&Zi$r41oTU!7(&NbYHkC1=57xQHTCAR8OaTLmz1yY z{+isNJv5}INAPQzkqe;74R9JCtjP`NXK``^dTJy$IQq&5JF**KO0ygE8m}kP>;`n2 z57z7k^jf6k5xnWPW;eX)wq`fH>9%G!yy>=PHyGa!inAN^kzLQL*$r>Huh|W6y06&{ z>S8&VpOLs3#oafu8;ZM+?1tj*OLoJX?iZ&w7~MD08;ZMcq&F0I-$-vL?!J-UP~3eZ zy`i}KMtVbW_l@)h?fw~CV|zj!=N3!bRdG&lSH-*|B;DTMJ;9XTXQ2CJ=Q1BTIhm%S ze4IAIoNhMNw)Y)SVx7JF7;}uXbD8ufW6a6UcHdF%J?$^Yo70_5wbO$}yU%g9x13}S zF0;tV$yv%}DfWkB-K*QJlgypchm3QNH1C@-#cZlP*U8B|4`n`6iq#(Wp}CD|u07{N z^8lA6yk%}W{|g$EEa_iNH`g(_bZ~OAbWGng!)$YQ*}%Uy+8cky2S)PGDEsWs%pGg) z=br~q4l`Qhq_X&6M&h${nVZ-%#$_ zBWIbbSH8#cKFR~8l!xhOW|`|b+h2Ze?(0ELPA(xR+$)z3_6c*$t!j4RpWV20{||fc zZz4x;clx=1;M633JhkCMQYl8BPTl#(nZ{mDG@$0n2A zKEZ09=xkn+{Bp4PA4T>{8IXQwfw`2~lwyCf*nH4> zk~c{?h4M91$~P$AGNqj6a)!%Ulygie=TW|6O8Fk;0#nKlC>NQRxcrDBwzybbdHHDJ ze`>~63eQ|EJbPWG@XXc1v)5G$&t5G&gI#$ByYkG{!n4;^3eQ|EaxyuFXR#KZ!LCw% zL%GYm>tr=r^*f6{Q0_6M+(&u9l=2Woj7oXLom{KaERAEY~it-jy%G)T_*#B<)AGhi#HJDOr zqSRtasf|*HDa8||E>lW9l=@654Nw{~r8Gim%#_jur78R0ttpFUD9xEtTA;LKN@<1S z#gyWW;=`2Ui{i(W;*S!*loE&%#FP?@(whD6)|v}n479XmN@<7Eo+;%W6k4swM&OfB|KP)4Lb{K34_Y(Krkd?kI&WpgFx^p97VEvEF3SDG_i?0wdn zBhwqLGw&*A^?muO*{i5))a&`n{C{SAOG97$GxJr+!8CU6ye0GQ?WT!e%so4AaCMq8 zXKszTx$9_J+r!DZ6&KTtoOYq@j_1>7ZE{{8{^AwQ%5EFo&MTPaw9e_4^YdpkH>=Hq zwwn^j8l1g8r{^COc4hnaT2AX}L5-0g|MX)LEgVs^!}gRjR$8?6r^+K&->1cwx814v zerZ}-eMHtz9h=g!;Wbumui2HBZ@DsN#IuRC;>T^iHO?-gmDNVLTsgRlRt>9uaogfN zTD|%5!4ac>qBWPc&aV;tlGd&~6f?DCX^LpRD&m`GH7MfikG^Q}b5mOPVXq0R&bB67 z=@z~2<#r`oY?;7b2dzVCeUE!}4sDu9>wo{IWSPY?X~UPXe||J$5p8U?^2#@(*VD#R zA0BJba~IjC^o(B>oJ5;SHQ#ivVIFNdSb9OPif3qZ_dli_a=J>J?|wa~^u7DEWkqcJ z4}biJwl-ba=<5@uY3s=kJ({OhqirAbc(HO$rL!k@p z_G{4f-OQD=dr{@KPZKK9?(bZ@t$X%vqv(218xGoDm!d!UrMipl07VymUoLfp5ACUV z)bd_fChZxY^1SjaqCLsc_l|yag7%u%-~4PsU)noh(GLxV{Xlzne|qZsexqpbpA+&H zcezdbIu102u)=Dfu^cTc&B zw7>3?>4RLh(Eb@ePqh3~m-ZKYH!S7x0Xk5jsLzDoyy?KWlunhdWzd17=%AttLkDj%H;ynM%89229#ZAAJXqm8u;_}b$Ng3`* z@g9X+CiIJ;__4`rDs}au_{7}{i`r*Ug40(yt*h;%gvR-4>nh)(gua;xcRdrNoTs^G&yxQ{wgaXNTVSnv&ed&Pe>JJSBOBepKS(KuQ|gZ_?QFnxO zW$BH#yd!#2O8lh?%U7O8NIIx8Q|UDYa3)DPsO`O6`;J^0&`-QtGUP zzd}B}NvS(y9&Vo2kW!CF-hDLX14@0c>6dO3<0!4_+G|l`A5+>p%Pu`1>2Ia9Nnzjh z8~Qn=t(pDp{sD(6Eq&Toran%Tc5QNDX!lN(?l$Id;=9Wzz17f+67)5t59ymUwrzPz zw|0%q3>-k|`)HqskDby_2SvT#;xeT_^V*u$&#!dCKaY(fQ8JDwH)d zA%uP!Mp-*z+HAVGgR+iA`ae8>ld|q_^6GlJA!S!t+cfgz`;^^&S^dAQM-Nf<#IV|Z z^Bz(5>e+9{9Z;O>g2LRlX57>b&PvLoD=1=9BOvo--&Vt_jxrYdMV}1 z@A52T=PAnB`_AL?Tgy?-w}F35-q@dV{%UnQFJdDduGQ$qTPuI0!<}nip0=zO9iCeC z`x6Vt(cz8d&eWN|hYshuowUyW{5LxM%fCfuK5I_7Wu6^rJZ&1~`aj4Fo03AgBY#c4 zIPq`FU3@LhYg}8(J@iA&vXNHG{r>c>>q84E_to+3K?B|BNP{ExwSBtNkzVN$ce<~p zBcH{uq<7EJk?s4IYznDDM~?0cd)Rgu9l2-!qHEv|$}4$1>&)BJD6dwbHT|Ee6)4Z= zNNVFsDU{baJ858r!IU>FJwB}5-;_5sIX1S;7Rp-?zyD&Xwv@N=;697{RmwZCFWSpB zjPi1KM~$#}Qr@|pJC>OWDev~yt;zqsM|m&oo36cbqx`bAjip}fr~JBWY=M9Gp!|R@ z*N%UBkMg@OUA5-V)s#QVx^PAIBQMIIVO{#`{d1JR|M-;hx6E4b&fO}MANPrM z%C8xeU-0o<`!B;N|H72d3vd2I`FAJHd~kg`<-Z>PY4xk`P(g*!)4N>0K?MzmPyOW5 zLMmuIWXjGT8c;#+0h3RCcbp2w^?C2vx%a7HW{>gp&XlBr6$&i7H7ab{ zs9StiHWjw7*ZFeBNGj}KyOUe$zf?G}dWdgw6cx^?+J1CmM=D%hvCWrpzfj?>azW{_ zOQ|rel>e;*jj8aYn{T;&C&^lP)$G+~&xcg_=-(ETc9*3hmzPa#kqK1v_OnJucJ!yB z7Jt_Ned`k{3VBes>gJ79H0bx*9qoZs^!~3kK3;!`iss#Vd+WL{s3_uEmE&t`Qqi8v z75`jygo-kM@TmReSStGFeAyn$%~W*bbg5ZOqN(WVDfiurI@8e-$6Zc`-?7rsnuX3U ztt;rL_YtQ?^P1Dqce7p%nDZ?i4NZGtojr|?ew6g=;LHkiG(7If51*va(G3S4o2L(= zqx<(hXf^d29X-73kKrF~rlV(f{I>LiHgxotEw_^={X|EfZ@hKwJu4k6v+hQz@t$b+r3G^=1nl^^48 z(wq*-ulu?b(cFTkzZ@ODm#iHFziFMgl)`T0{5aH{LJK^9`nE#cURpTzb^bTj(2cZc zSMAhgmSwc~ChhMKKbw};9lPz-un%b2xCLu7T!zu|UAq^}Na#r`ZWhgMF}y9UtozH9 zJFYEh)p*y@yAo^B>fMb7j2uyx*4*mah7(vUV)m^0w3VLND3(u!~PCRCx#{kL{m-NB}F~I6u&jJEA8rbu`x5@0dJlgf!&=j)x~p3?3gt)*)Eh9**U(~86DT0WxaIo0jucv-?EGLeBjsXO8h9=lht;`sbSSi6ulsx1pT?h{eOo^Id;G9PwD0ar|NbsSF|Fs%p!k0%X2p{DR>LwV#`@#xKWe#r zM*ExEo0LxQru}nvzV~w2J=%YA->$nZ`{_Wn_-hvvCencqGHM(jUY8DJ<%OoXT&060 zPi%}%*g^+~ojGqCK9~+3xKw_DYehQv;zqA&38yKx`)?~o5C4*4w>&!D+qEmj-hE+d zo5)W*ZJa}z4bP)PUzVI-&2=tW4_&U1?VcD!am}hddp7(D#eGrF@3w0q#hq$4{kz1E zD89OHT;Yf&6hEcS?@6w=DL%VXQNo_I*gfVLO86%0REhwHr zJ|%8AJ$}0R3MC#sAATpaH6{M?L*(c2$V) zr86b(usjG0ji%&dCCWUDw>neu{W8rzwv3^aDjwZ$hvrgB`^xW+jITi{6W?C?y=4xi ztggAYXXr&rN%Jf!j1Qocs|{|ov237J*QTbV&_5})Wy?BE;`>qRV4wC;mUv2?A29N* zVPz)ie6M^?+vls2_b#h-_D zptOwxe1^wIQd;hizUM8kDed;~kGl^WLFr{jugZ_lqV$0AvB55HQTnJ!CliLvr1T|I zerpu}J*CG@bKB|SOX(LrZCGVk1f{>8-Dy?)1IlPPcf5;BFUsg07Cv{_LCTo9Xy=~^ zB`9OZvfL>ylPTla$}85J!;VqL{k1Pc6Y5iDl?`v7by+}}?KcN?9d?~ECvG2nB%wWJ zu8#UF&}AECrtPuC4SPYESNA71NEk|4u7}QScS)nHmWdB44X;dDgVV}ZQ|>!8-F#i6DR+`*g99U+ zDR)hSPM(QlC^x;yxXrG)lzXj3c=-`E(!CCu_q$pB+?LF1zON?rF4Zl&;6*HjmY7^) z)|sDa?2-+KmR4v@6PL~Ed9JM!O<6JYkDBkDplO|JzMInJ1kE^JwsPo|gY;RK*FXO| zeGSbz@gQZ7>kOLH?fRnbTL;tJlV=A!^lDAk9tHI_9IZuRw?jYQe#nUyG(3A_+N>G0 za8mbf9YcQRcj$cuiB(Durp0&KymjZo30m4XIV?M>H7$F;*`3u>4$|`d(S64T)T9-6 zYh?I2t)Z1oH`H-GWujG6$}GLK;S*YYaPfoK(Ld9g-(L^0HXTfBH?|oa^I`%;1kAFn z8@-JpE+ilSf?vGW&3y3ky{2W!R<(Jn-fQ?BI(_o^z$ex)T0bP(?irdz>z`deRWkQ6 zZP--f^^^L|X=6~R&ri!I(8h}!CLX)LgY2`^8U45Q7@3qBZhCyTahe!b(JUXN*O>(=KQCpV|9KhAQk@YV#{HYYjw<-8rVz1oA1 ze!h8uwr4ks`qtXDJna}h>HG9UU1`V5=n_#C!f5B#>+M#|%A&|xWrH&B&!Nbv&HKki zRiVh-?jPN>3%;9Kt3K`Oef|CiXZX&s z<6rmD3rEtf2Q}*s^nXFS-)Ymf>z$3Xdrj!zc3XXD_qAEmtUkR?Q*^5hD;haXp=fJz zboFF+iavcdxBPq2w5Rrii@auO&$Kd+o}c`Q_T)7$b${L*+FQPRgIiuzXz!TG@BDBx ziS{Ne3H^FQAKK>>{Yie8KWJayf>o(6meIb*>-!EIs!#hKzRuq{I*(#PYFu7lVI;*w zw0^p*=mo{x2(^}*H)|v9_ny^cMpGZ!AHJdE#4D$1|Jme`!`FOB2RzTt>f6Dc4orU# z(dkJv9VjSsFnC`G9jwsoXv@%_=-{|+*Xos?LkE*4J+FGC3dK4vsaSe?62m^s&I^{IQe{$AqZLJR}zVJc!MQ7b9p`>e4+x&Bs;8XcX zVD&nbFs%O9-k*L<2@8BLHT&i;B^>B*yJ4eJlyI)!pLN1QDdELfr)rmCD6#IeGL?P) zqQvgjYUNgT;& zUz&6;x*8>oyYuO*n9N~mrT88C(~pl0DmRSMw#`4^XL1as6|K77E&ne{`(xX^PSyDxy3)ZH?LS>d z>20&!g1)&y=@U*?@@>?L(pO&cY!Nn((o^oVY;@@qrC)j0rmk-_%5ZV*T4N>OAzD-( zROOd6${19CoX0yB%9!W-aj8xHDPvEExh{{QDC3)c%bmJ=@U7Xpue`KVqvyLd`Z|<$^9Wca{v3@cY&1q9TBEU_ z(H@M*9zpq5SoZ*i_MnD$OVL3L@j--nV=>gR8t!dEu^9402>Tww&>xcU zFGqh5J+~T>_c(-s-f>tw{6li~AZ#GRAj z`(%zk@7cSRub)`QDH?~aM=6*KDTqg>U{0hUE}eq8k&5_qD&|P4#;HRn6>}vO@#<8} znKZ<$(=d0^jQBNQKQW2YG>|=-(lD9Q5YSG?q)JC%I~|iN9RcoiOtN$hbkCyKjY%*U=Y@BJ;Ue z9Y-`mzn_j^l^j8&{s>mf5k%~dVAbSld(h=%SXsRAImNuq5pg=zx>Ho;}bwWmSH|V1>|En=Hrt< zK9*%ZJ`Ln!c^2RkK>?O&0X`KJV7V6HlR*KNZGnC|xJ(6Dz6Dl%Lny#HF2J{h0<7l( zd{ZdIx-P`Gg+i?FLVRN=#5ym;w}wKj_dZsnD_h3-Jx25Z8ese2XZ; z^`J<;;3=`;20!6VjRVV z;LuIc9wPpksOg zvi{(N|4}EzA_sz_5R;q${l3N~&(l1*&X+0XSUW1`aX#*Ov0YTA?XpmilqwkX)4cmku>1H%=vj$6h&=xdw3xcLw z(cou7+<>n`+oH=?h*CH%`B-<@Q2eJxSgXpBHKqOs8!iD*P+_h3Z!AUeATBePedwEnag zBeWOM+I<+QeTdrb!-&NodK-h0i?M1Lw<_(&5bj4fcRz-5zlL?)=m3WF0K&TmFti5| z<~@iZK8SE{EQUH(!@j>!EQb6L!oPxI0K1@VBIT5~0)VOjNN`g<5 z5MNG$Z<7#bPJ)k<5N}R~uagmXPKM8u5r0nR2z-vkI)IXYG~&=Hm;)(@N2g#eq#!Px zf;o|b_;d>9Mk?aeshA_Fh*zg#uB0Mvor*b=rt#|^C{5;$b(lY;A&{MhNtA|wb{ZyA z8Uowtm{jQ+;66_2m|W=ybf;sIr6b^-fytJEz;^~FT?PW+89eu_dlRZs1_I%kn1q=K zh-YFlW+E`2iAkA>0C^@RXBGnGS(v0*2$*MKvSuN0o`p%9jR1PK&(~J{NRh3P^dXdu zS)7fCdNyWrHX`denAJImu;*ZQ=V+w83*}&z=OE&K7_klIWe>l0FG5ZfA z5}%7zkgE~-r<9A;kc-HCE>=aZ5us0C^jcz&oe+Z@2#!K5asu@Gh)GVx_URg%45m-9 zf2PJLP4qdA`vS4b`8YldG0Sk&TY%W*BBMUPLnDZ}1csI(n7JGVS0JeQB@C}baC0?I zuttNNHEAtQv=+h62%K;of}ZPeVw(~Cr1jbWYfV~@Am|1(WCMbs8_^&;f}(abY!iZ` zo6*3{2$F6=L$@GUx)lxHhM?&-G<-XPr#qwrRu22_KooT+da@JI)JXIw5>eGi^ejrF ztJ^6GJ&Zz>br*WNOQWsjXcv0C8&TKY==pAqzJ^mYkAPL;&(Ru%&7^3IL^PtYdoUt< zG%DMS_F!c8B09SlBeYkewA*PPMrt3Twfit)F&eckM==<=7({RPmzZqTfcJh4eNr89q-&+&LM( zPv-cugrBV`SjQ=dL#JRaq#z!hf;o|bxO58UMykfA`JEYaBo%S$RLqrBjaPq8shBfq zh+C&&?xY#ESZi1F3*dk2$1BjwCoo{Ne^5Z6{27Wj z|FN2vk9}1WOF*>%FaATKAg^HlGfCOcfBodsGSDZ$FWA@qQxnUQYQEn5FJE}^-=X>h z@qYftKKWk<2;zU`$R{9uUQ^5D?f=&aK5zHmQ^>ywHeo^(0bI-sko$E&ToLj0RNo_#HL zcZh$({-=A?x*6i%CdIO&!k!TSM(@vmOB?1ZPi(*L%&&Z!+R zu8!;dDGNgekH{)Lz@v7^;Bkvv&c9*}89em(gh$OAhYSu)Zti;DJ7nOntZTXRVAEm>(z?PiPqlk6bE!xR|~Sf3I?nN~I{epId%|t_i8F?sT61yZQi+RK`oj<0_m;CdI^|%O{k^_#UNywOOV8!8 zIV(f_J3lzOsBLSe%{2V$cxFI5-;oVM{NKIwdC4p1nR8Qae$G5B<4>1Ke#<^j>ti^ua{nRp1aM&ZA#}h^*4{I75eAdiVH*h zYrbj~WAkA~P6?~GkJ)kGkdzw#FKgVs)ynr|h<}Y0wOxzeVYV1{bzmw_k24!nzZ=i| z%}qwW&Sd>RIcrAm zL#289|KyK67EA!lEI9nZ)wwU8*E~q!0C-eWtklcNJ+wyV$lUNl0 zYj2I-HTvJXsohHdr@;M%Wz^sXH_Kms7&3UUC162GURn+gy7^_Le}3g9mUr!|oLS7B zevxf^{DN7q_CS6(@!uUN`EL)D{C5XR{@Vkk56FLe zpxO`g2LnL<+XLOte|Mndzdca$#ly6N&%+lIWm~1y$%+5=KsU4p-vJ2>0Xu;Fw+DKB zC-7acGuQ>}%3R7P><03m9jN9%Jy7zW9hjE#`JMQ04@^s#{C5XR{@Vj3|J{L-|Mo!1 ze|MndzdcY61o`g{R1XIE?+#S+-yWDgX1n}%2g+d}|LK8h{<8y`NTECh?dqu?>{ICuj53Oos( z67u<-zQ%@cm^Zk53!VngFt2kt3!VedgWrMQgBQRbz>DA|@JH}6(|Vo%a|IiI0uS>V8cD|KKKB92tEQIgMWfgz^C9} z;4`Mo8*!UZ=8I4!s_-SB-$^FeKU{>bz}Miv22BjvZ;~HEXV45;7oKELiL4VD4Rg5|*Spa*jkmZq>GbS1DdSOu&Kz6HJwRs*fo@uLP<6RZW+W`^^L zhB7mlq2MrZI5+|v3626sgJZz4;5dU;(|Bx{0KNxK1Sc_hEt@8T?}HzJQ@{_wkHD$m z$KW(3uPoDaaE6kv|DRyPr{HHyUW%rf;4E-9_&GQS{DPUr$Ik`lf%8FevFr~6c{Eio zV5ag;(?a>dTm&u#mw-#bW#Dpf1^6Yn5?lqY2G=lC*#25D0$j(m$_^VgtOqxM8$mm` z3ET{B0k<-f+0Hg_JGcYf2}XiZ;4WGJQgJsnM1y<4z2H7D2Hej~;(7FM#jbd|F9rGApEfBC_UaN=H=cr=vk4ki0d$rDh?E5M0+ZOR0*z-%xFJPhW7N5DKV zA1vVWtHDCB2s{cNWAbpDj)Nz_ufUVwDe!A1Pb?EpU?tCZ-nSQab?mIpnURxwlo8!Cd8nA|Am z%3u|+D)<)2b@e!Itg<>-1FQ+w0&9bHKu=!(TCpxR)C22-4ZwyxX6#?*Mqp#G3D^{D z1~vyffnX4mSBP^k*cxmDwguaP?ZJ0I0z>%x zYN!L)5$puM3w8#(fV={na=8KB!0uoVuqW7yd4!Ma4fX;1g4TZc(H|TD4g?2*gTW!- zP%xAk!zUO94hKhoBf(MNXmE@{tMgcF7zd6ACxGvP6PXcwqDkOn@O|(Da0>V#_z^f2 z{1}|3v^qIY$A%fqIedaoz)!)?z?tAIa5nfk$aS^;7fdeBbHRDwd{A62`@@7RoWuDC z_ttpiKlu$cmO;I z#)5~yI4~Yekh6=yL~KX`lfe`wPdw*TFbzxxGr&wR3(N*{z{4OfS+#cr%;WRxhJ3Jq z$ur)$5G(?Zg2%w);0f?6@FaK&{2KfQ{1!aToWSR?p23f^;5qO-_#OB?cmezYya-+b ze*`Zxc_}+z0e=Fog4YaMov&lV4e%y-3;Y@U1-uRZ3f=*KV~*n!-UWXL{{ZiS_rV8B zUjGlV;Su;4{FB*(4L$*%f`5U}z`w!g;0y32_z(CBd=369WdEC)aw4;d*`4VO$_~*M z&;@j5`to)+&>buRmIOGRPp~dn53CP102_jhz{X$`uqoIKY!0>nTQa$k=2o))xz%Pb z-XP@0D0vi=JUU80&>su{1Hm9L7;Fu;0o#J@!1mxfe11IvfgxZACJ(E*BiM<_^TYfu z*ct2sb_KhEJa6=Po>$7AU@x#YXzha^eZhWUe{cXem&q$d{(U#)d{8TU?dm??gDp%(cm6%uaJk&ypMm}XU2g0!2|3%7v6plj0F#Y zabP@{049P-Obgdf22;RPFpX)I1Jbb}1Iz@oz-%xFJj^t6y_|JC0++3GgfMBzOw^8vF+QmdQ)jd>T9ho(0c==fUs5@4*Ya{?)(_yupVJ zU1ahSGV=se{s>-X@)9#&0e=Fog4e+7;0^F5c#Aoj>;DY?0^Vl->yBT+JK%5NUGR7C z5AYty^Tsrb4fD)a^2}F00w05af=|Gwp!F~Ocn1CrJ_lbgSMv#8g8zW8z}Miv2HEX; zyu}1MgFIivj)f0U^29dnVgFlPjUN^_&>buRmIOs5U^%cnlP9Rf1G)lO z5v&AOW*%n$TdL>}CrefEE%0ry8ptzP4c7o`f=#%~ykaa(nY`vL&A{eh3$P{F3iJ}P z|1CU&wIWYIr7!3Q`ZK@e;{w1yFbE6=TZ3)DwqQH3J@^htOzWp?ID~%)JAfU*PT;#> zXRr(NGd`YIgpyZ`vOCxV>914bl z!@%L-2yi4g3LFiN;q$A(vDh#U91l)l%B+2lIg2?FoCHn=-v>Vcr+^=VA2G$wRPbYL zpT_4`!_%3w`G6VVCm_2;xASl-c~q3#7$w(Heh$t7zX0cg^T7F_oR{lZtYP>O4lV!} zf{Vb#;1cFquDBFj1}+CzfIMOKxRoHgO*M~#a*aW&g^lTk2yh)}1J{Eaz>Q34xgFdD zZU(o2TfuGMc5nw%Ipv13qL|zW3$J12ZZI0;tCeo&i;r?27z6HS@^8xl@E{lq z9s=XQcp>}2l7J0~U=o-Nrhutn8ko+M24{eoU>2AS=75L6TqcjQ6~RhiWv~iZ zmD!UGz6HJwRs(rdbw77bSre?Kv^u%e#)dkeC$kqDtP9oy>w^uzhF~MGG1vrb3N~Z* zW_!)S7GO&u``@J%|9Fq-1$u)%AiG2N^RO%Znd}yq05A{?0)xTUOm>?~8?Y_d4s6eq z=YN-Xuz{FjI0Wo~?H$2R;JaXFunX7~>;`rR+21m`UD!=Z9$h7midBE~!G^wIKd?Vj zCglKdAUFsd3=RQ@f}!9ra5y*u9LeN);4(_qzx)`D4P(Hu;5cwRI00mLX}yWyByckG z|5SC}@zz~swe~w-0dmz4d%Na~Aq0_fb~$^Wtw@M1HpE~$zy06}$459`>G(*;ZzpQldG){J?{fTZ$HzE6*718B zzn3VZS3RzP8PiF#PLTRpXB&sM1FUb zQkAy~o=kiSKe&eY6GU)};1++<@u!GvjgrN;_*BQe+_ihsfJd5*v6NLed?f#VAue~HL4n*E-(l z$U5x@uOsqz`t^>#<@g52-*$YXfvN~hn=0>xV#-{W|zHf^|&mI55 z@h=_!%JHuq|Hkoei4WoTf9Lr3j_*ak75sza`-n2~exh37HphQ-{3pkMcKjE|e|7vf z$A5SH56Ay>{4XM{aQgo_UiIGw|Ks?99?uZ8;+YeU2aYElPdT0@(wt}X1I61p-rn&J zj^{Z3FCzWs%m?>))tL|Rf)8~(*YS>y=Q)0uyEuNb<6Rv;#qn;6 z?Ef=&_kw#k-jldz`Jv;&ap|~nTss~)ZXCCc$BsM4PbEH{dOywaUc{@k;M2X}-j0_z z-pBD$$Io#5Ovlf1{A|b1A!>szbNpQ5H^4v7@$((O!0`*Ux>mTa7krW9{fG}``4^jC z?s$L4FLC*oI)0hsmpgui;{zPO(($Vt|BvHW%dUjJh6Ue9{94BcI)0twgB-u!@xhJ{ zabzRf@2RUr>T2_2OXd2_(P6A zOysv`e#G%di9f@(pLtRTXMW7_#~q*Sc#Y#z9Dl;`Cmnyv@u!JTN8qWBjG)G!=7?D1 ztkdE%T4ek`(+i&E_-x1L5LxNWwT{<0KG*SQ9e2T}FB)A5fr_O#$#UhpT5?{>V!@jZ^W zI{vBSpE>@y<6k)brQ=^Y{-Z0j?<30K`yFp{{6}s+(^1d- zljA=-{)^+kI{usEzdQbi<9|9{^+{1FZ|`^q$8&nTO8K}yp!Wa#Jf`8ogFWByo=)} zJF?D+yR!fF-&ooY?&f%R$9p*5lgL);Ke4p9a9ldB9M_IVjvL3V5lhyyu|T7jUQlSt3ke`0CzvmHOj@iNEHb^JWX&)4|Z55K?* zzR>Z$MCO3oeUan+9KYD{a>x5Seu?9k5?{vezRdB<9lyene$&dolK67g`znur{Wq4j z;H!xe{u=YIb$p=X*Ev4O@#`HQ?D!C(419y*Lmj`-@tYjKnJAraVOV_7oB3XNt$$j1 zr&G&aq1E9)i-GtD_kF$9YM}K%{4+t9ZU)*8G&EL2gYTIAi}lc04~?}nuKWmGt)8XZZap(AN@B#n-w(b3R28X8AKRVSz<~Wr0a$P(0U;Lv1qUPxHJxqxBIgI4q6D;qs|(QJXCeR|VDujtXoFYzrJ0 z*a@6GyIAZ$@CVwY#bV*2Mb*5hniuSXw>Gf_yTE8O&~~8Xfp!g1|8oE2x3>D1?B)K` zC41S3y=*ijmP2AWB$h*BdAvXSwq}L@2PuTaYJdLQn#79M>4huyfDwDZh&^D$9su2r zpKcyVJ^YvSPdc+$Z37<%-c6VxJ=SMXPk0%4Rru6`p}oKSVf53*`e>ldK-+QXjSC(kR~s~p&@e*72n{1NZhmn41sXnGEc4#ort8{2=(YU&K*`m=A1HBL$UWSGd8b)Xsp<#rE5gJBA z<9KN7hQ@Aa?9f;=FFQ1h&@e*72n{1NjLp(NLc?fiEQZEnXe@`ua%e1v#&T#Z(YU-h zU7}%xh7lS@Xc(c<5r^>o1)rlfSfOErh7lS@Xc(bkgoY6sMratJ(Glal(9qxzUdx7t z#<_nnG}hW5_m;mk8b)Xsq0y1X`E_kQjdLTlRbQsI>PY*eBkhllv_Cr1{^&^iqa*E) zhBVHNhQ?-SY|yy8uc!Udk@iPN+8-The{`h%(UJB?LmKBsXc(!jwrYc|+NvY9RYz*8 zj(VH@zCIazQ66Bcv*4kwZGufhO}NsTCXE{ z=}2BWl9!I;r6KJ%BYEk|&Cfp(NLc<6RBQ%WAFhau!4I?x< z()?^RG?qg{^Rr9QxU_lE{A`4V5gJBl7@^UT=4T@`jLp(NLc<6R zBQ$Q**e3!(a_L1@5{Dmw3%?dMZ*XU zBQ%WAFhau!4I?y+(CA3x+-PWMoO{{O(EO}rr`OEStNo=vbGr+Hy5cfymv!g0rR}<| z!**fUAcLLjv<};)U5D-3uETb5*I~Q5>#$wkb=a=&I-JxP^rPOUb|)@281*b{NLp8( zgRi4QX&Fk(P+Er4GL)8~v<#(XD6I||{sT^Gi%D%UsVye8#nA(o`wLzzXA3TB3UW#Bl?FC{lkbpXha`0q7NF;2aV{19cfN58X7uh^Rl7QuFaZ*c5T+t(9k)Xe=#)H zXqwbAk~XMratJVT6Ve8b)Xs4GmqJdD+m=oY0pY4-L%;UWUer&y+vS2}Wob zp<#rEk@iRb1sWac*l&b}5gJBl7@=W=h7lS@Xc!F*9sAp|jgI{n+zY3hLo|%gFhau! z4I?y+&@e*72n{1NI?}PYZ)51t>u7$UkD8^L&FFSBQ%WA=t#$YBQ%WAFd7=V zHuEwxZoIp6muMKFVT6Ve8Xf7_Z-j;s8b)Xsp>f_lRC7D_cZ7zQp<#rE5gHw7oL~3e zJ6w4B?1o!01ENw(ktwKc(YgOdW8FyY)t8}jT}S8`q0>>jK5M1z`m7_VbR?0E&@e*7 z2o0m5q4Rt%8yfBUtktq%Q!eia4I?y+&@e*72n{1NjLTcQE8C4bSx{4t?t8kJv0{bvOPq@2n{1NjL_&v zW8DZ1BQ%WAFhava) zY*9frN$||sE#rQ-f6DvLTzGoR0e-;c1XmMWPw;4hn+a|wcs#+~fXo0T!3;3qq{fAQ zUwUe*qy6Fm=P+ArH3bw@J9?=a(olQLP`j%`%>xCs!@N{`%uu_`5VhN0sotP_vPNhb zA!US;5kehlE-*sI2o)nljE2T$Xl#bYW@zZRf919EvO%LG%>_ni7@=W=2It{=x`Kug z8b)Xsp<#rE5gHw7E-*sF2o0m5(XIuaCNdVwt z9jUE4Qd@O2G<41HWoTU2OVKbwqoHHX1x9EXp<#rE5gJBl7@=WQ8pnsFL9XK})m+fm z(>1@*(BO=Jf8sn^=vc@78}8T;8b)Xsp<#rE5gHw7CNM(72n{1NjE07;`MqptEQbb< zRjYJp=(yj1q4RsAp}}L-{eznO6&glpocG={Y#YyF3Zda;Xc(c`^%d@9b=5p zFhau!jgHi>jLnFZ&L_QWXsBO#+0anG>dV@7WAoRp8#@{r>Q^WFGBk|P zFhb+fZ&Zt~&@e)yBlRmIw!?_+Fhau!4I?ye({kG7u9B~{Dm9ryZ|`zv*KV8_k=0d+y|rMjRu)CIkv zF6a$)L2sxF`VKjc45-@&UOK69TIstP7>sJ01Y6_P6Pt&W@wXfKv0)anomaJZ}2zILq`+pB<-}1*cm~J0^j# zblhUv@yKs1l^O>&gm+Ri95=Lf+*Te-rREi+_Mkt#!$tiT6AO6`eaPiyTcKge)pF?- zwqRSQZQm>VZzak3L0c}(!V)bkRbwWI2}`$@OSf=q)m~@2<5bH-m&u~9e~Nb$w)=ZN zfZJxEgIu2WGrv5{dk@B z;!k1e7M5=PR=S0yTUfe$h!-uJhDN)y&qWkJ*obuL*DwSuS>M6Dodi@UYT81Dn3R!dPUh+09^I%Jej z5Vcy0T0ztb4z-0&0ct5~S2qs}odgs_tsrVQw5DF@JfI+I1yL)AT0ztbqE-;Kf~XZl zt>C2A&NREQ9{+m>ooHU+l(M?Ad!`nbTZfrG_nf5pS~qs_u4 zn`MDjfpvkS0-FL=@un)?RK;6Y%u9V;n|JyQ%J9~Pw`F)+hPPWg-yRp(85~zj99PB1 zRq=5-K3?x1f2Fqf_^5#cjz3pjsmN$5l;DtRea6@pc?e%hOc1hLC#!(qW7kF+_|QAw~=kBgTgj!^4QtVZ`9* zNF!0`M*})F??BU{iu4kWz`=%H_avHqvvxdk z+&FF>j~&@1CaSZ~;Ob9J9AGFAH&?2*eB4evZ#%$xu{ntG~4a&$8P;YtQ z6V%jIG@?C>(72#!=(^cRGkjmB3BDuE?;UA+??|(IN1EIl(oxa~4WW}O2HhQ>NCT~w zs|F5uk@egs(m*RZrAyp_SG*LfUQdxb@QT*#OBj3xePoucEo#;^ZgwGBtU7k{r>;)uc00i&e@hD!&Gmj*V>a~&-9?|&S9 zkj;MI<5UepPzwO-0!IZl1-1o_3+xQGhXs1YCs!Q$-t*(CaJy>YV71-f^5c@?(C3m( zfo*}~0y_f^eSKvPeFjxAhrY8{OMye50q-`mQ_rjZ?E@Ncy+o1-kfeg@2+>i zi_;zO-gF1O;)7Kmpu7V$#*prt-q?Du-jy;MV@S_S+p_kqlu?bL^%$q?8mA}Mhqk`v zASm&J^tKl^mqTGP&e0~VbBbZM_K+)FUr0frmk1k_-$zvDCXqoe(~&(M#Kn4wqz zSQlW5>Pt2Swgrw0>B@Dw3_#og}eU&Fa ztF6KZ2P`>pQ`JU&ZaKuqk;DCL3%X85_;`Gxc>jHEMbY zK4R?kC5%0R1J0AwiBBE18_GJ_JJQf=r)ftTdPYnfMob*-)a{5f^ln9`q1qtcNGjm= zIAZL%$n9~&iJq6ZJ&qWBUeep+#L@mm*Pe4R)m6O=y=$H)0lpFuIG_VR`FUy%hMr6K z2&J#WHz*zO2}%caxDNQnr2~3g1B|`1&sW9FBmxHvi1VMXiW%H4Vd(W$Xy*!9jo==FLxRqv+i-MC&Z{rV~lJp)F_FRNk>fM;LS04)LFL$m$)FOoI~ zK$pwj zCmPV$>wv!2K~>Bd>NT&_DJ*@WMY=?b^oSPe5G~RlTIAg81|0F4Pyx=p`jTY`qjO({q1*r?&Vae6FJbQKfVroG_5Rw| zsA7hkzyUXdp7R=2%)!nj+{Wpva2uxqMw|gRwE7ZmXm!B-p$^vj!y8pG7li@`%rN)7 zQ5EmDRdQT_!?RYQC2rCxTMl+w0O07{0Y~Q!I68O0(YXUAwb!+kX$pX2 zFzgIyiN1uE=zx~!fF|yMChmYcTCZ2doMj4deZGIr>s2wwxn9C?&VZI^>oV>PXo>hJIks+eadZ&1YyJ1sc5TIhpyxz_I1r0aV!9lS{*U6!)bH-XLXQ;KvNK<5>^~eB*Gw54&jIzGi)p1bk+|@B6 zI(K#Sx5nuWZ4=pfJ$jQFTb;W;4rYCQ*SFP2&us8k-#oLyTYd6OOC0NqXGMKVt*9@l z6<3b>j#^xwQ7dw+xv2pTHh=?ei$3`#)yUanFJU|xa8}dS-L-G1`L&KJajXUU z;P|2gPM-PRm>W**b7PjbuZzA+YPpBPhP`@)zSIezgm zF(r&616rUjXj8E`t&)@3vqa6Z$Qa6Z!k=QAD9 zUEiUK8BhYcEqBQ~RIv_Vt%Mtw1`L6|gg)B=owfsdZ3hg44jB3GRK=V!3g|xHP4862 z9Kd=BXAK6-u5De8$_C7?eaWT(S5b=LHK0?*4mcik!1161jt3oZJm{bt@3^bU#_$pmS3Z1VcOf@gc`i#*ipzfTnhQ>k z#1x&iXV;^wJ-wco6G(VXJxQL*^elN|dYU{jJx`vP6IZyFnU_jn(aX5o7r$#yv_~!N znfAn-Y{I{D!U;1coiKCa2{R|SFq0ROSC~1`MQ809_b6*mxhLkN7hZGbrIKH`Z04ns zV6-wP!q{K)SLfW7D@f(SX!xL~!|1qY#4v72F^pSY3}emccQS6-F^pS+4C9s~!?>l% zXqbc6q}!8a^mTf^4C6N2TYw?Mv|gmm`bFBzU!=|co$xLw?`x1jqc=%q(J*VT!;G@_ zMoh8x3eNZ)4-2A}_9D(y*4~a8ztj6FQ<>fznOJ(MY#Y5Tdcuvq&Ca>e3B!;hj<<{_ zcR|`=s!H0Ssz^Ir6={d8BJHqMq#e3C;p9gdKdi}tp)`4=WpePz?FE-A6Kg3n^eYh^ z*;;iXElEd}v_u_6bf6onwS*m2(vo%*X^A@;IdJk0m-GZ4Mbbe}eRD+@scPN8es{;3OX|>c`>wSw9#L){e-7&8+le^C+8HaRQK1Xou>tW;X+umabI4`4lTiCW?O`6Gl|ZBq(S=?(B(X>_jw->p86S)r@)Ogem0;Z8 z4#p#vVBAIz#{Ilt+|vs-^WuafcIKob#qdHx5i>mv4ThIsde}CtsRwQo!^_PN9<|^l z7+!+WF2QJ*V0f9BUTg}6mtc4ahL>P7FHT(I?Q`;yVlyvJVp3&zA@PWr9>xa4OEA0y z!%Hx{1fyMo(JsO85{z~UHuIvFqNXw@KCw?HKPiTn#n^@&UV`Bz7+!+mB^X|U;bpK& zj?(p(`Uo$|XqRB=rIMx8@9=WlecjeeeXJ7P?2}ZjF z!%Hx{1ezys17#sq7Q;slQB2{bge6FB4OLnV9Ms*he;G{kZZP$isch!OiDujq`hY3coOyB5nZ9Nvo++l^UFz*?uSo>c zHcVyOhKXq#CZ=r|O#LjFwqYvMHcU+IIkA}+eY6&3GcP*6M;TsjzE5p~6W4hA)X%0e zeT)zcFTwB<3@^d(5)3cF@WRz}>ER_9?J_a-vtW1$h8I%TxEA%ZV0a0Jmtc4ahL>P? zA(2hhiI<7BP?SxmLyB^X|U;UySeCZ^+iFuVlAOEA0y!%MK4 z7bny4wmYFtF}&P*Nwtd;>-4g7^3z*o%(u zq`)bLmtc4ahL>P?35J(ocnOA=V0a0}KAM=0@4;qXmNPF-++){zwffSr4Nl-wWq64) zyadBbFuY7m$M;}(35J(ov`a9&ki5t0PV`d@FHweb+ zcnOA=V0a0Jmtc6AnC9JJv`aABCD_bM`#{;wri4YZeQHWtRMcOU74?^8Mg4V|X?f+^h9;&vd=rzMiOJ2x)I<}Lm%*5Ylg+$TMx^eHH;;17nHSzbS}OCA*K~Fy zGbczgbB-i4CobxYS-9mcGIO#dGv`Y(bIK$$XH7D5;v_TYPBL@)Br|7FGMjl}7M{Gc zSL`o;s7FqvQ_{XYO>!lAa+EQuf-$OsF{*+ws)8}9f-$Nlrdc=`qbeAqD%i|RySp`9 z>m}h>bLPdVn7l>0%8E7dLNXQpOEA0y!%HyQg~UpwhnHY@nV4qb zV0a0Jmtc4ahL>P?35J(ocp-_By*Ry7F}zG=nuUYmB^X|U;UySeg5f0?UV_cMI1QA& zC=KMare@(_GcQgH<=^Qli>FhTc z?GkL}MQ?nPB+5SZ)@Lxh1j9=(yadBbFuY7mXTQPl5)3cFW?r1W%FcB5d*j{9r_)$f z8D63cFTwCKF`fMe!%Hx{1j9=(+J&T5)^n<>Vzf(?;UySeg5hOins<4J_QLi!gS=Ll zNs61K*h#AWROeci63c$t9j>ViKP0QFGW-O?&&1jtuCZpj!!3@^dhPr+!L zU^6dHqh)8h^DwR1?r;qSr_}PA`r_*HsSGc{@DdC!!SE6cFTrS+V0f8WyTdi~oO;V% zbOs!2&b;Uhn3P+!CSHQ!B^X|AzId#Omtc6AnC9MKbeUjy35J(ocnOA=V0Z~O^WyYf z-Ug@eGSl2U{jNP(7~9}At!GuMp14XqQ+s zy;St<+IX&RT*BQ3@^d(GBM4)!SE6cFTwBoR@AA-iaPyRQKuj)>NI3Uor=tq898k*BhTpERi!5DzvUYo_8z&z z-0YR2tSD`jrP_h9vU*ccb*G7HUQVhG6{YG?LDi*#;)-M+?l(?lRt!&3hNWOQ3WlMH zX>JaNonW{LhM8b9FHU)8FHU<_Z05!3&#DYBBsnwF+#C!q!SE6cFQi_n-{B<~9XlB9 z5)3cFXqRAknV9D0V0a0JmtZq5PM>CHPN7yz`{-%qS{X2cX&+5x+DC(FZVsk>G?i%| zO-%b}V%kR&qg{f{yy&hlY0m6Zsn&zxWw1)W*4N~1)L9u`VokgR!%HwtKBaf8r@q0` zOQmNky_pxy&C~Cks?BS*v|2+!=f$LKt1`UYaL2*$5)3cF@Dhx635J)6X=V;ay9A?M zg5f3D%!|&8qip8IsouN|O3M{%&b;Wncq-FV-(WK@P66jSod&KLUP#VX3@^cGmtc4a zhL?%yyf_$Mg5f0??GlW32{!YhbK)qQd2#wUyLJjWvvxmXY>`vRxyMx-mteF@Fxn*;?GkL} z#cA#AOyelloOvN-Rg`HQO>1f#1)F(k_w~lMJMEqIbbWbZDx+P3;f3UNwI*JI;bmeP zN5SwC3@^cGmteF@FudGWcljz!p4Hpi6H^&pVokhEOyejRUV`Bz7+!+mCD_c1)9KlZ zQ|cAN3(53~;bmg&{AH9m#a>%;O0##_{ypEsd1w zDfk*abJAJ(8oNE2SV+U?5@+HwtDEGqcjjc>B=4+l*mqVp>^rL)_MO!Y`_Afyz1Znf zoW=C}@TPUk-c-*INY&Tuu(JG+n6Ib|1#Ri&rqX((;i~G9hG{)$F|9`$osI`BruCr3 zv>vpW%9S3an97w-zD(sRs9Xh=tDtffRIWtz=tznF)L7!}z0#5Quc&NAscZ!;TmEfp zEKb!;WlQJIrm_`Owt~vmM46mtRE-s-auu}g!Xd;2Ju98Nsw9E^^;YKzylDU0`=7XY zBn#}cy--cYz&lqVU(1mqaIDKa#xvRy2u`Ifi{M0CD#3}ie1a2gNd+gmoobHsf^Nvl zFlfqr-4Y8Hb)LbZPBmDxeUor*?Gxtg*>Ck#0yzO|Wv3l1>db>h^^ruZ>^y)jW#-P( z_RYq$awQ_HmE|f*osO_d<%;ZqMV*wesPhsQm8)2J?ut1)OWW5Q)5=FqQ+V0!_2zSB zDr^H~%2qfihcq$^4yt2XP#x5Q>Zmr+_CPwQj%z`6U<;}vTTmU^f^s}bimUTh!Ve)x}>@TqVU-Qd}j)RZ?6fox5@t#B$|Kh=bya42MN^8JHATNpY1FS4nZT zxZ6|}u9D&^DSI#}ZIu*P6J^?*Q(R>!u9D&^>C9DSQ}p)I?YPx9JXco5QHrZ9#nlaC zcUOkRT3OeIS&FNqxJrtvq_kC1TqUKglHw}q+*P|soJ{KWU97B^hmzuoJc+dl&dfL{ zu5O+hN2j<+ag`KTNpTfar@2XSl@wQDLua~4X{%g$?n*htFX)eXPLW*F*&J&Vl+7wj zaTQc2yh(AD6jw=cl@wP=ag}uL%2^-Fl`bH2<+&@J`d&G0k)Eq0#Z^*VCB;=zTqVU- zQug3=)8227SAyayO4|dLsZ?jdS&FNqxJrtvq_|3otE6*Rx|x@yb61+%qg2mYlFnV} zJD-kbd51|o^G=E@Kj2hi7dsHANfjGPrsAmDye#Ve{$VcR&NiAtEB4fQHraHwog2g;wtIP zRr`0iSvqso{xNQr;%eH!r84FwowXIYHfN=}T@fp5ZcmDUHsRxvs5;u zTzT$FPiC@o?n+;MM9rGplj6!xhb5%BJt?k|(pE`vl@wP=ag`KTNpTfab9+);wFftx zcf3_q`&c9>uCf$YNpY1FS4nXdv^`LtYHqW9P+X1oAQ$c54kuOjij~#7 zf~s=`Ro@D#t`$^0YohV^Mw_p<`s+$x6jw=UtE9Mkif;>OWn3l2RZ?6f#Z^*V1=TE{ z6jw=crAzttChLNvtaFO1EX7q)TqVU-Qd}j))kIf1gHMX9q-v|*C|50^Yf@Y##Z^*V zCB;=zTqVU-P|fm5wFf5~x-I>bptMy|?ZGJ39t^5I7*u;OsPeTm{uEpA=U~aWzdcq@0~oTxBV)lHw{UuBJ(*<)clC ztDu_Plj15Vu9D7O=>dG`>H&PNjH{$`S2}~w(zz?m?NO>T_@r}J`Z^#>aWzeSB)Xkb zTxBV)lHw{Uu7YZAPl~H)He0p-4L>F~GULumag{6MDk-j#;wmYwlHw|8JAJg2j^YF~53%Iyq(^qlsO)u%nU*4&pH zNolK~?F@c2`&xHrqGp}JPZt9u9;S3$SFGE|T|wn4sPwB30Rsy!G~doZZ>U{G8=B`B_v;wmYwlHw{U zu7YZAPl~IgxJrtvq;ps8ynQmMyED16_F#YGf(wMT?z|_}9-K-wwY#<{-1EHtO-6T zuCAU|Zr?ggo^|`(sXnwty8WIMS4nY|6jw=UtE9LJstG`9tLO~6>7Eo?>&o$YSxXJEX7q)TqVVo^PRNc;wmYwlHw{U zu9D))30SDAedCrCS4p)8d#;$avi4w5TqVU-Qd~JdP5UjblHw{Uu7YZAPl~IgxJrtv zq_|3otE9NPb=rh>Vh}Na$s-_MZ|a*0XGT&Gugtrn1%ScRkm3t=Y3}7i<6YVESSE zp9-Dgru}Dy_7i>^nm~!^% zTG#ofJN18PC|UoXhKV{2cCGA0*hQTRyQq_47j-)9qE3iiw5Ovk*7H$|@o#n)`tJ_a ziv52)3`gxhJxpxX(p|fj_Fo^SvYr>a$~Ln#duHq^b5iP}&PpwcoA#d}hMUSu?R6_L zbx~)gF6z|OMce<47zX)oWBk*Ii8@hst?cyFMV+5o6jSZLN(@t#q1x-NoT9p@b5s{~ zlIo()QeCwD=ZRs8|25gNU90povP=QjJ*+Nt`Ck+>s!2RbTQZ4hWu2gBDN{gFrhueO zOi7uTk}@$R#nqJ$8Lss8T+nuReJXA5J_f~Au8gasxJrtvq_|3otE9ME+;6zj&6l8> z#FH{zCdE}!TqVU-Qd}j)RZ?6f#g&s*a{S|8Xw0Z4@hH_Ko)lL}ag`KTNpUqz@%*=q zImK0$;wmYwg6af)I`ACpt(c^^N;-F?C#PA8tE9L}imRl!N{XwX?dHokN*(J2Jv_JM p6H$t*EX7sQd0XkpX|$yO+edrB=H;*dpAY_+kKaH3NhiPK{{v=O`YZqd diff --git a/examples/dflowfm_piave/dflowfm/roughness_M-0p023.ini b/examples/dflowfm_piave/dflowfm/roughness_M-0p023.ini deleted file mode 100644 index 7e9eaa31..00000000 --- a/examples/dflowfm_piave/dflowfm/roughness_M-0p023.ini +++ /dev/null @@ -1,11 +0,0 @@ -# written by HYDROLIB-core 0.5.2 - -[General] -fileVersion = 3.01 # File version. Do not edit this. -fileType = roughness # File type. Should be 'roughness'. Do not edit this. - -[Global] -frictionId = Manning_0.023 # Name of the roughness variable. -frictionType = Manning # The global roughness type for this variable, which is used if no branch specific roughness definition is given. -frictionValue = 0.023 # The global default value for this roughness variable. - diff --git a/examples/dflowfm_piave/dflowfm/roughness_W-0p003.ini b/examples/dflowfm_piave/dflowfm/roughness_W-0p003.ini deleted file mode 100644 index f5f445fb..00000000 --- a/examples/dflowfm_piave/dflowfm/roughness_W-0p003.ini +++ /dev/null @@ -1,11 +0,0 @@ -# written by HYDROLIB-core 0.5.2 - -[General] -fileVersion = 3.01 # File version. Do not edit this. -fileType = roughness # File type. Should be 'roughness'. Do not edit this. - -[Global] -frictionId = WhiteColeBrook_0.003 # Name of the roughness variable. -frictionType = WhiteColebrook # The global roughness type for this variable, which is used if no branch specific roughness definition is given. -frictionValue = 0.003 # The global default value for this roughness variable. - diff --git a/examples/dflowfm_piave/dimr_config.xml b/examples/dflowfm_piave/dimr_config.xml index 7ccfe521..2887573f 100644 --- a/examples/dflowfm_piave/dimr_config.xml +++ b/examples/dflowfm_piave/dimr_config.xml @@ -3,11 +3,7 @@ 1.3 hydrolib-core 0.5.2 -<<<<<<< HEAD - 2023-09-21T09:32:17.058397 -======= - 2023-10-20T10:56:37.467991 ->>>>>>> main + 2023-10-24T08:17:19.050552 diff --git a/examples/dflowfm_piave/geoms/boundaries.geojson b/examples/dflowfm_piave/geoms/boundaries.geojson index 54bc1509..3260b82e 100644 --- a/examples/dflowfm_piave/geoms/boundaries.geojson +++ b/examples/dflowfm_piave/geoms/boundaries.geojson @@ -2,72 +2,37 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::3857" } }, "features": [ -<<<<<<< HEAD -{ "type": "Feature", "properties": { "level_0": 1383191.056227589, "level_1": 5854440.8114257297, "height": 17.349960327148438, "bedlev": 701.4000244140625, "width": 60.93007025, "branchid": "river_5", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_5", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": 6, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "where": "downstream", "distance_right": 4.9175380812341708e-07, "nodeid": "1383191.056228_5854440.811426" }, "geometry": { "type": "Point", "coordinates": [ 1383191.056227589026093, 5854440.811425729654729 ] } }, -{ "type": "Feature", "properties": { "level_0": 1393846.8667426864, "level_1": 5859166.3015384898, "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E140", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 168, "elevtn_up": 1144.300048828125, "elevtn_dn": 1112.5, "invlev_up": 1141.800048828125, "invlev_dn": 1110.0, "where": "downstream", "distance_right": 5.8166784782944824e-07, "nodeid": "1393846.866743_5859166.301538" }, "geometry": { "type": "Point", "coordinates": [ 1393846.866742686368525, 5859166.301538489758968 ] } }, -{ "type": "Feature", "properties": { "level_0": 1386078.4202513243, "level_1": 5859854.3928082353, "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1239", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 364, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "where": "downstream", "distance_right": 4.0088765079104887e-07, "nodeid": "1386078.420251_5859854.392808" }, "geometry": { "type": "Point", "coordinates": [ 1386078.420251324307173, 5859854.392808235250413 ] } }, -{ "type": "Feature", "properties": { "level_0": 1386045.2509392484, "level_1": 5859913.8590362957, "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E276", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 447, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "where": "downstream", "distance_right": 3.8584702415109949e-07, "nodeid": "1386045.250939_5859913.859036" }, "geometry": { "type": "Point", "coordinates": [ 1386045.250939248362556, 5859913.859036295674741 ] } }, -{ "type": "Feature", "properties": { "level_0": 1384484.1807617808, "level_1": 5857184.3018050948, "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E9", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 458, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "where": "downstream", "distance_right": 2.3880128290434959e-07, "nodeid": "1384484.180762_5857184.301805" }, "geometry": { "type": "Point", "coordinates": [ 1384484.18076178082265, 5857184.301805094815791 ] } }, -{ "type": "Feature", "properties": { "level_0": 1384480.7748306419, "level_1": 5857195.2444554009, "height": null, "bedlev": null, "width": null, "branchid": "pipe_15_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_15", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_15", "diameter": 0.5, "index_right": 467, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "where": "downstream", "distance_right": 5.3722077541611869e-07, "nodeid": "1384480.774831_5857195.244455" }, "geometry": { "type": "Point", "coordinates": [ 1384480.774830641923472, 5857195.244455400854349 ] } }, -{ "type": "Feature", "properties": { "level_0": 1385834.1594623995, "level_1": 5858793.8441787036, "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E47", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 519, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "where": "downstream", "distance_right": 4.9733410300668418e-07, "nodeid": "1385834.159462_5858793.844179" }, "geometry": { "type": "Point", "coordinates": [ 1385834.15946239954792, 5858793.844178703613579 ] } }, -{ "type": "Feature", "properties": { "level_0": 1385177.8775195002, "level_1": 5858363.9756671879, "height": null, "bedlev": null, "width": null, "branchid": "pipe_21_E4", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 525, "elevtn_up": 758.9000244140625, "elevtn_dn": 756.79998779296875, "invlev_up": 756.4000244140625, "invlev_dn": 754.29998779296875, "where": "downstream", "distance_right": 5.341153742051576e-07, "nodeid": "1385177.877520_5858363.975667" }, "geometry": { "type": "Point", "coordinates": [ 1385177.877519500209019, 5858363.975667187944055 ] } }, -{ "type": "Feature", "properties": { "level_0": 1384799.2182603152, "level_1": 5858488.5922634779, "height": null, "bedlev": null, "width": null, "branchid": "pipe_23_E1", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_23", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": 0.5, "index_right": 528, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "where": "downstream", "distance_right": 5.7240456036556167e-07, "nodeid": "1384799.218260_5858488.592263" }, "geometry": { "type": "Point", "coordinates": [ 1384799.21826031524688, 5858488.592263477854431 ] } }, -{ "type": "Feature", "properties": { "level_0": 1385472.2180530226, "level_1": 5858925.2730725091, "height": null, "bedlev": null, "width": null, "branchid": "pipe_25_E2", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_25", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": 0.5, "index_right": 535, "elevtn_up": 791.20001220703125, "elevtn_dn": 783.0, "invlev_up": 788.70001220703125, "invlev_dn": 780.5, "where": "downstream", "distance_right": 4.913263386404469e-07, "nodeid": "1385472.218053_5858925.273073" }, "geometry": { "type": "Point", "coordinates": [ 1385472.218053022632375, 5858925.273072509095073 ] } }, -{ "type": "Feature", "properties": { "level_0": 1388962.2407159139, "level_1": 5860301.717001454, "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E73", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 620, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "where": "downstream", "distance_right": 4.6166295054686266e-07, "nodeid": "1388962.240716_5860301.717001" }, "geometry": { "type": "Point", "coordinates": [ 1388962.240715913940221, 5860301.717001453973353 ] } }, -{ "type": "Feature", "properties": { "level_0": 1386273.1738117875, "level_1": 5859335.3654602878, "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E12", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 633, "elevtn_up": 717.60003662109375, "elevtn_dn": 711.0, "invlev_up": 715.10003662109375, "invlev_dn": 708.5, "where": "downstream", "distance_right": 3.577770704512787e-07, "nodeid": "1386273.173812_5859335.365460" }, "geometry": { "type": "Point", "coordinates": [ 1386273.173811787506565, 5859335.36546028777957 ] } }, -{ "type": "Feature", "properties": { "level_0": 1387692.1617963261, "level_1": 5866783.4206203762, "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E7", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 867, "elevtn_up": 816.10003662109375, "elevtn_dn": 802.4000244140625, "invlev_up": 813.60003662109375, "invlev_dn": 799.9000244140625, "where": "downstream", "distance_right": 4.9781434926194598e-07, "nodeid": "1387692.161796_5866783.420620" }, "geometry": { "type": "Point", "coordinates": [ 1387692.161796326050535, 5866783.420620376244187 ] } }, -{ "type": "Feature", "properties": { "level_0": 1387975.2799954726, "level_1": 5866107.4257222451, "height": null, "bedlev": null, "width": null, "branchid": "pipe_48_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_48", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_48", "diameter": 0.5, "index_right": 892, "elevtn_up": 803.9000244140625, "elevtn_dn": 786.29998779296875, "invlev_up": 801.4000244140625, "invlev_dn": 783.79998779296875, "where": "downstream", "distance_right": 5.3234291644079913e-07, "nodeid": "1387975.279995_5866107.425722" }, "geometry": { "type": "Point", "coordinates": [ 1387975.279995472636074, 5866107.425722245126963 ] } }, -{ "type": "Feature", "properties": { "level_0": 1394694.0702762168, "level_1": 5867648.108302163, "height": 22.5, "bedlev": 865.60003662109375, "width": 60.500781333333329, "branchid": "river_1", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_1", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": 0, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "where": "upstream", "distance_right": 2.7120132961912311e-07, "nodeid": "1394694.070276_5867648.108302" }, "geometry": { "type": "Point", "coordinates": [ 1394694.070276216836646, 5867648.108302162960172 ] } }, -{ "type": "Feature", "properties": { "level_0": 1386066.8097397459, "level_1": 5868052.7264932301, "height": 13.574996948242188, "bedlev": 813.29998779296875, "width": 63.595319, "branchid": "river_2", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_2", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": 2, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "where": "upstream", "distance_right": 3.4269831423038173e-07, "nodeid": "1386066.809740_5868052.726493" }, "geometry": { "type": "Point", "coordinates": [ 1386066.809739745920524, 5868052.726493230089545 ] } }, -{ "type": "Feature", "properties": { "level_0": 1391540.018037077, "level_1": 5858077.5772200329, "height": 21.70001220703125, "bedlev": 952.79998779296875, "width": 50.0, "branchid": "river_3", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_3", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": 3, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "where": "upstream", "distance_right": 8.367694927529332e-08, "nodeid": "1391540.018037_5858077.577220" }, "geometry": { "type": "Point", "coordinates": [ 1391540.01803707703948, 5858077.577220032922924 ] } }, -{ "type": "Feature", "properties": { "level_0": 1388521.2575925963, "level_1": 5855362.0276134778, "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1045", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 169, "elevtn_up": 968.29998779296875, "elevtn_dn": 968.29998779296875, "invlev_up": 965.79998779296875, "invlev_dn": 965.79998779296875, "where": "upstream", "distance_right": 6.2550722664998962e-07, "nodeid": "1388521.257593_5855362.027613" }, "geometry": { "type": "Point", "coordinates": [ 1388521.257592596346512, 5855362.027613477781415 ] } }, -{ "type": "Feature", "properties": { "level_0": 1384050.267680947, "level_1": 5856698.7020015484, "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E195", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 365, "elevtn_up": 814.29998779296875, "elevtn_dn": 802.9000244140625, "invlev_up": 811.79998779296875, "invlev_dn": 800.4000244140625, "where": "upstream", "distance_right": 4.5480020130277707e-07, "nodeid": "1384050.267681_5856698.702002" }, "geometry": { "type": "Point", "coordinates": [ 1384050.267680946970358, 5856698.702001548372209 ] } }, -{ "type": "Feature", "properties": { "level_0": 1384196.86181646, "level_1": 5856829.8804841097, "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 448, "elevtn_up": 800.79998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 798.29998779296875, "invlev_dn": 798.29998779296875, "where": "upstream", "distance_right": 4.7301652606593837e-07, "nodeid": "1384196.861816_5856829.880484" }, "geometry": { "type": "Point", "coordinates": [ 1384196.861816460033879, 5856829.88048410974443 ] } }, -{ "type": "Feature", "properties": { "level_0": 1384289.0655242952, "level_1": 5856954.9478410175, "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 459, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "where": "upstream", "distance_right": 2.9575907640532436e-07, "nodeid": "1384289.065524_5856954.947841" }, "geometry": { "type": "Point", "coordinates": [ 1384289.06552429520525, 5856954.947841017507017 ] } }, -{ "type": "Feature", "properties": { "level_0": 1384512.4849668304, "level_1": 5857248.8580293376, "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 471, "elevtn_up": 805.0, "elevtn_dn": 796.29998779296875, "invlev_up": 802.5, "invlev_dn": 793.79998779296875, "where": "upstream", "distance_right": 3.7745466738450301e-07, "nodeid": "1384512.484967_5857248.858029" }, "geometry": { "type": "Point", "coordinates": [ 1384512.484966830350459, 5857248.858029337599874 ] } }, -{ "type": "Feature", "properties": { "level_0": 1385352.4717880946, "level_1": 5858398.702550319, "height": null, "bedlev": null, "width": null, "branchid": "pipe_21_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 520, "elevtn_up": 756.29998779296875, "elevtn_dn": 765.0, "invlev_up": 753.79998779296875, "invlev_dn": 762.5, "where": "upstream", "distance_right": 3.3313663649888272e-07, "nodeid": "1385352.471788_5858398.702550" }, "geometry": { "type": "Point", "coordinates": [ 1385352.471788094611838, 5858398.70255031902343 ] } }, -{ "type": "Feature", "properties": { "level_0": 1384748.1072519517, "level_1": 5858475.4653943758, "height": null, "bedlev": null, "width": null, "branchid": "pipe_23_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_23", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": 0.5, "index_right": 526, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "where": "upstream", "distance_right": 3.7932856782999725e-07, "nodeid": "1384748.107252_5858475.465394" }, "geometry": { "type": "Point", "coordinates": [ 1384748.107251951703802, 5858475.46539437584579 ] } }, -{ "type": "Feature", "properties": { "level_0": 1385425.8717415037, "level_1": 5858809.5220389515, "height": null, "bedlev": null, "width": null, "branchid": "pipe_25_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_25", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": 0.5, "index_right": 532, "elevtn_up": 786.79998779296875, "elevtn_dn": 791.20001220703125, "invlev_up": 784.29998779296875, "invlev_dn": 788.70001220703125, "where": "upstream", "distance_right": 4.9875171671174047e-07, "nodeid": "1385425.871742_5858809.522039" }, "geometry": { "type": "Point", "coordinates": [ 1385425.871741503709927, 5858809.522038951516151 ] } }, -{ "type": "Feature", "properties": { "level_0": 1385861.3725137978, "level_1": 5858893.8325690301, "height": null, "bedlev": null, "width": null, "branchid": "pipe_29_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_29", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_29", "diameter": 0.5, "index_right": 536, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "where": "upstream", "distance_right": 2.0428258687376185e-07, "nodeid": "1385861.372514_5858893.832569" }, "geometry": { "type": "Point", "coordinates": [ 1385861.372513797832653, 5858893.832569030113518 ] } }, -{ "type": "Feature", "properties": { "level_0": 1387137.2230088995, "level_1": 5858981.7231069598, "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 538, "elevtn_up": 769.4000244140625, "elevtn_dn": 769.4000244140625, "invlev_up": 766.9000244140625, "invlev_dn": 766.9000244140625, "where": "upstream", "distance_right": 1.0826199317136784e-07, "nodeid": "1387137.223009_5858981.723107" }, "geometry": { "type": "Point", "coordinates": [ 1387137.22300889948383, 5858981.723106959834695 ] } }, -{ "type": "Feature", "properties": { "level_0": 1386030.9264584926, "level_1": 5859869.8815911002, "height": null, "bedlev": null, "width": null, "branchid": "pipe_36_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_36", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_36", "diameter": 0.5, "index_right": 726, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "where": "upstream", "distance_right": 5.0283226172582603e-07, "nodeid": "1386030.926458_5859869.881591" }, "geometry": { "type": "Point", "coordinates": [ 1386030.926458492642269, 5859869.881591100245714 ] } }, -{ "type": "Feature", "properties": { "level_0": 1386043.3811057615, "level_1": 5859908.1192919631, "height": null, "bedlev": null, "width": null, "branchid": "pipe_37_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_37", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_37", "diameter": 0.5, "index_right": 727, "elevtn_up": 766.29998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 778.29998779296875, "where": "upstream", "distance_right": 2.4131141216608354e-07, "nodeid": "1386043.381106_5859908.119292" }, "geometry": { "type": "Point", "coordinates": [ 1386043.381105761509389, 5859908.11929196305573 ] } }, -{ "type": "Feature", "properties": { "level_0": 1387931.6147025716, "level_1": 5866170.5421204576, "height": null, "bedlev": null, "width": null, "branchid": "pipe_45_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_45", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": 0.5, "index_right": 878, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "where": "upstream", "distance_right": 6.266084733821659e-07, "nodeid": "1387931.614703_5866170.542120" }, "geometry": { "type": "Point", "coordinates": [ 1387931.614702571649104, 5866170.542120457626879 ] } }, -{ "type": "Feature", "properties": { "level_0": 1387940.4436740221, "level_1": 5865845.0932547273, "height": null, "bedlev": null, "width": null, "branchid": "pipe_47_E0", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 886, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "where": "upstream", "distance_right": 2.7377250423463006e-07, "nodeid": "1387940.443674_5865845.093255" }, "geometry": { "type": "Point", "coordinates": [ 1387940.443674022099003, 5865845.093254727311432 ] } }, -{ "type": "Feature", "properties": { "level_0": 1392926.9667947688, "level_1": 5866808.5014050379, "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E125", "branchtype": "pipe", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 893, "elevtn_up": 909.5, "elevtn_dn": 910.4000244140625, "invlev_up": 907.0, "invlev_dn": 907.9000244140625, "where": "upstream", "distance_right": 2.3433279429140186e-07, "nodeid": "1392926.966795_5866808.501405" }, "geometry": { "type": "Point", "coordinates": [ 1392926.966794768813998, 5866808.501405037939548 ] } } -======= -{ "type": "Feature", "properties": { "level_0": 1384118.7186508661, "level_1": 5855518.21493336, "width": 60.93007025, "branchtype": "river", "bedlev": 701.4000244140625, "height": 15.174972534179688, "branchid": "river_5", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_5", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": 6, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "where": "downstream", "distance_right": 3.8448292198833252e-07, "nodeid": "1384118.718651_5855518.214933" }, "geometry": { "type": "Point", "coordinates": [ 1384118.718650866067037, 5855518.214933359995484 ] } }, -{ "type": "Feature", "properties": { "level_0": 1393846.8667426864, "level_1": 5859166.3015384898, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E140", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 168, "elevtn_up": 1144.300048828125, "elevtn_dn": 1112.5, "invlev_up": 1141.800048828125, "invlev_dn": 1110.0, "where": "downstream", "distance_right": 5.8166784782944824e-07, "nodeid": "1393846.866743_5859166.301538" }, "geometry": { "type": "Point", "coordinates": [ 1393846.866742686368525, 5859166.301538489758968 ] } }, -{ "type": "Feature", "properties": { "level_0": 1386078.4202513243, "level_1": 5859854.3928082353, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1239", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 364, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "where": "downstream", "distance_right": 4.0088765079104887e-07, "nodeid": "1386078.420251_5859854.392808" }, "geometry": { "type": "Point", "coordinates": [ 1386078.420251324307173, 5859854.392808235250413 ] } }, -{ "type": "Feature", "properties": { "level_0": 1386045.2509392484, "level_1": 5859913.8590362957, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E276", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 447, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "where": "downstream", "distance_right": 3.8584702415109949e-07, "nodeid": "1386045.250939_5859913.859036" }, "geometry": { "type": "Point", "coordinates": [ 1386045.250939248362556, 5859913.859036295674741 ] } }, -{ "type": "Feature", "properties": { "level_0": 1384484.1807617808, "level_1": 5857184.3018050948, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_11_E9", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 458, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "where": "downstream", "distance_right": 2.3880128290434959e-07, "nodeid": "1384484.180762_5857184.301805" }, "geometry": { "type": "Point", "coordinates": [ 1384484.18076178082265, 5857184.301805094815791 ] } }, -{ "type": "Feature", "properties": { "level_0": 1384480.7748306419, "level_1": 5857195.2444554009, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_15_E0", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_15", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_15", "diameter": 0.5, "index_right": 467, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "where": "downstream", "distance_right": 5.3722077541611869e-07, "nodeid": "1384480.774831_5857195.244455" }, "geometry": { "type": "Point", "coordinates": [ 1384480.774830641923472, 5857195.244455400854349 ] } }, -{ "type": "Feature", "properties": { "level_0": 1385834.1594623995, "level_1": 5858793.8441787036, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E47", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 519, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "where": "downstream", "distance_right": 4.9733410300668418e-07, "nodeid": "1385834.159462_5858793.844179" }, "geometry": { "type": "Point", "coordinates": [ 1385834.15946239954792, 5858793.844178703613579 ] } }, -{ "type": "Feature", "properties": { "level_0": 1385177.8775195002, "level_1": 5858363.9756671879, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_21_E4", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_21", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 525, "elevtn_up": 758.9000244140625, "elevtn_dn": 756.79998779296875, "invlev_up": 756.4000244140625, "invlev_dn": 754.29998779296875, "where": "downstream", "distance_right": 5.341153742051576e-07, "nodeid": "1385177.877520_5858363.975667" }, "geometry": { "type": "Point", "coordinates": [ 1385177.877519500209019, 5858363.975667187944055 ] } }, -{ "type": "Feature", "properties": { "level_0": 1384799.2182603152, "level_1": 5858488.5922634779, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_23_E1", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_23", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": 0.5, "index_right": 528, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "where": "downstream", "distance_right": 5.7240456036556167e-07, "nodeid": "1384799.218260_5858488.592263" }, "geometry": { "type": "Point", "coordinates": [ 1384799.21826031524688, 5858488.592263477854431 ] } }, -{ "type": "Feature", "properties": { "level_0": 1385472.2180530226, "level_1": 5858925.2730725091, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_25_E2", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_25", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": 0.5, "index_right": 535, "elevtn_up": 791.20001220703125, "elevtn_dn": 783.0, "invlev_up": 788.70001220703125, "invlev_dn": 780.5, "where": "downstream", "distance_right": 4.913263386404469e-07, "nodeid": "1385472.218053_5858925.273073" }, "geometry": { "type": "Point", "coordinates": [ 1385472.218053022632375, 5858925.273072509095073 ] } }, -{ "type": "Feature", "properties": { "level_0": 1388962.2407159139, "level_1": 5860301.717001454, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E73", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 620, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "where": "downstream", "distance_right": 4.6166295054686266e-07, "nodeid": "1388962.240716_5860301.717001" }, "geometry": { "type": "Point", "coordinates": [ 1388962.240715913940221, 5860301.717001453973353 ] } }, -{ "type": "Feature", "properties": { "level_0": 1386273.1738117875, "level_1": 5859335.3654602878, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_33_E12", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 633, "elevtn_up": 717.60003662109375, "elevtn_dn": 711.0, "invlev_up": 715.10003662109375, "invlev_dn": 708.5, "where": "downstream", "distance_right": 3.577770704512787e-07, "nodeid": "1386273.173812_5859335.365460" }, "geometry": { "type": "Point", "coordinates": [ 1386273.173811787506565, 5859335.36546028777957 ] } }, -{ "type": "Feature", "properties": { "level_0": 1387692.1617963261, "level_1": 5866783.4206203762, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_42_E7", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 867, "elevtn_up": 816.10003662109375, "elevtn_dn": 802.4000244140625, "invlev_up": 813.60003662109375, "invlev_dn": 799.9000244140625, "where": "downstream", "distance_right": 4.9781434926194598e-07, "nodeid": "1387692.161796_5866783.420620" }, "geometry": { "type": "Point", "coordinates": [ 1387692.161796326050535, 5866783.420620376244187 ] } }, -{ "type": "Feature", "properties": { "level_0": 1387975.2799954726, "level_1": 5866107.4257222451, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_48_E0", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_48", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_48", "diameter": 0.5, "index_right": 892, "elevtn_up": 803.9000244140625, "elevtn_dn": 786.29998779296875, "invlev_up": 801.4000244140625, "invlev_dn": 783.79998779296875, "where": "downstream", "distance_right": 5.3234291644079913e-07, "nodeid": "1387975.279995_5866107.425722" }, "geometry": { "type": "Point", "coordinates": [ 1387975.279995472636074, 5866107.425722245126963 ] } }, -{ "type": "Feature", "properties": { "level_0": 1393117.0441566666, "level_1": 5866704.0716401814, "width": 60.500781333333329, "branchtype": "river", "bedlev": 849.79998779296875, "height": 24.5, "branchid": "river_1", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_1", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": 0, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "where": "upstream", "distance_right": 3.7966561587080121e-07, "nodeid": "1393117.044157_5866704.071640" }, "geometry": { "type": "Point", "coordinates": [ 1393117.044156666612253, 5866704.071640181355178 ] } }, -{ "type": "Feature", "properties": { "level_0": 1387829.3683439796, "level_1": 5866704.0716401814, "width": 63.595319, "branchtype": "river", "bedlev": 789.5, "height": 15.025009155273438, "branchid": "river_2", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_2", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": 2, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "where": "upstream", "distance_right": 1.8276004259190638e-07, "nodeid": "1387829.368344_5866704.071640" }, "geometry": { "type": "Point", "coordinates": [ 1387829.368343979585916, 5866704.071640181355178 ] } }, -{ "type": "Feature", "properties": { "level_0": 1391540.0180370933, "level_1": 5858077.5772200329, "width": 50.0, "branchtype": "river", "bedlev": 952.79998779296875, "height": 21.70001220703125, "branchid": "river_3", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_3", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": 3, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "where": "upstream", "distance_right": 9.8891646795509848e-08, "nodeid": "1391540.018037_5858077.577220" }, "geometry": { "type": "Point", "coordinates": [ 1391540.018037093337625, 5858077.577220032922924 ] } }, -{ "type": "Feature", "properties": { "level_0": 1388521.2575925963, "level_1": 5855362.0276134778, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1045", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 169, "elevtn_up": 968.29998779296875, "elevtn_dn": 968.29998779296875, "invlev_up": 965.79998779296875, "invlev_dn": 965.79998779296875, "where": "upstream", "distance_right": 6.2550722664998962e-07, "nodeid": "1388521.257593_5855362.027613" }, "geometry": { "type": "Point", "coordinates": [ 1388521.257592596346512, 5855362.027613477781415 ] } }, -{ "type": "Feature", "properties": { "level_0": 1384050.267680947, "level_1": 5856698.7020015484, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E195", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 365, "elevtn_up": 814.29998779296875, "elevtn_dn": 802.9000244140625, "invlev_up": 811.79998779296875, "invlev_dn": 800.4000244140625, "where": "upstream", "distance_right": 4.5480020130277707e-07, "nodeid": "1384050.267681_5856698.702002" }, "geometry": { "type": "Point", "coordinates": [ 1384050.267680946970358, 5856698.702001548372209 ] } }, -{ "type": "Feature", "properties": { "level_0": 1384196.86181646, "level_1": 5856829.8804841097, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_11_E0", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 448, "elevtn_up": 800.79998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 798.29998779296875, "invlev_dn": 798.29998779296875, "where": "upstream", "distance_right": 4.7301652606593837e-07, "nodeid": "1384196.861816_5856829.880484" }, "geometry": { "type": "Point", "coordinates": [ 1384196.861816460033879, 5856829.88048410974443 ] } }, -{ "type": "Feature", "properties": { "level_0": 1384289.0655242952, "level_1": 5856954.9478410175, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_12_E0", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 459, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "where": "upstream", "distance_right": 2.9575907640532436e-07, "nodeid": "1384289.065524_5856954.947841" }, "geometry": { "type": "Point", "coordinates": [ 1384289.06552429520525, 5856954.947841017507017 ] } }, -{ "type": "Feature", "properties": { "level_0": 1384512.4849668304, "level_1": 5857248.8580293376, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E0", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 471, "elevtn_up": 805.0, "elevtn_dn": 796.29998779296875, "invlev_up": 802.5, "invlev_dn": 793.79998779296875, "where": "upstream", "distance_right": 3.7745466738450301e-07, "nodeid": "1384512.484967_5857248.858029" }, "geometry": { "type": "Point", "coordinates": [ 1384512.484966830350459, 5857248.858029337599874 ] } }, -{ "type": "Feature", "properties": { "level_0": 1385352.4717880946, "level_1": 5858398.702550319, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_21_E0", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_21", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 520, "elevtn_up": 756.29998779296875, "elevtn_dn": 765.0, "invlev_up": 753.79998779296875, "invlev_dn": 762.5, "where": "upstream", "distance_right": 3.3313663649888272e-07, "nodeid": "1385352.471788_5858398.702550" }, "geometry": { "type": "Point", "coordinates": [ 1385352.471788094611838, 5858398.70255031902343 ] } }, -{ "type": "Feature", "properties": { "level_0": 1384748.1072519517, "level_1": 5858475.4653943758, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_23_E0", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_23", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": 0.5, "index_right": 526, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "where": "upstream", "distance_right": 3.7932856782999725e-07, "nodeid": "1384748.107252_5858475.465394" }, "geometry": { "type": "Point", "coordinates": [ 1384748.107251951703802, 5858475.46539437584579 ] } }, -{ "type": "Feature", "properties": { "level_0": 1385425.8717415037, "level_1": 5858809.5220389515, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_25_E0", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_25", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": 0.5, "index_right": 532, "elevtn_up": 786.79998779296875, "elevtn_dn": 791.20001220703125, "invlev_up": 784.29998779296875, "invlev_dn": 788.70001220703125, "where": "upstream", "distance_right": 4.9875171671174047e-07, "nodeid": "1385425.871742_5858809.522039" }, "geometry": { "type": "Point", "coordinates": [ 1385425.871741503709927, 5858809.522038951516151 ] } }, -{ "type": "Feature", "properties": { "level_0": 1385861.3725137978, "level_1": 5858893.8325690301, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_29_E0", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_29", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_29", "diameter": 0.5, "index_right": 536, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "where": "upstream", "distance_right": 2.0428258687376185e-07, "nodeid": "1385861.372514_5858893.832569" }, "geometry": { "type": "Point", "coordinates": [ 1385861.372513797832653, 5858893.832569030113518 ] } }, -{ "type": "Feature", "properties": { "level_0": 1387137.2230088995, "level_1": 5858981.7231069598, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_30_E0", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 538, "elevtn_up": 769.4000244140625, "elevtn_dn": 769.4000244140625, "invlev_up": 766.9000244140625, "invlev_dn": 766.9000244140625, "where": "upstream", "distance_right": 1.0826199317136784e-07, "nodeid": "1387137.223009_5858981.723107" }, "geometry": { "type": "Point", "coordinates": [ 1387137.22300889948383, 5858981.723106959834695 ] } }, -{ "type": "Feature", "properties": { "level_0": 1386030.9264584926, "level_1": 5859869.8815911002, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_36_E0", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_36", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_36", "diameter": 0.5, "index_right": 726, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "where": "upstream", "distance_right": 5.0283226172582603e-07, "nodeid": "1386030.926458_5859869.881591" }, "geometry": { "type": "Point", "coordinates": [ 1386030.926458492642269, 5859869.881591100245714 ] } }, -{ "type": "Feature", "properties": { "level_0": 1386043.3811057615, "level_1": 5859908.1192919631, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_37_E0", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_37", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_37", "diameter": 0.5, "index_right": 727, "elevtn_up": 766.29998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 778.29998779296875, "where": "upstream", "distance_right": 2.4131141216608354e-07, "nodeid": "1386043.381106_5859908.119292" }, "geometry": { "type": "Point", "coordinates": [ 1386043.381105761509389, 5859908.11929196305573 ] } }, -{ "type": "Feature", "properties": { "level_0": 1387931.6147025716, "level_1": 5866170.5421204576, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_45_E0", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_45", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": 0.5, "index_right": 878, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "where": "upstream", "distance_right": 6.266084733821659e-07, "nodeid": "1387931.614703_5866170.542120" }, "geometry": { "type": "Point", "coordinates": [ 1387931.614702571649104, 5866170.542120457626879 ] } }, -{ "type": "Feature", "properties": { "level_0": 1387940.4436740221, "level_1": 5865845.0932547273, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_47_E0", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_47", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 886, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "where": "upstream", "distance_right": 2.7377250423463006e-07, "nodeid": "1387940.443674_5865845.093255" }, "geometry": { "type": "Point", "coordinates": [ 1387940.443674022099003, 5865845.093254727311432 ] } }, -{ "type": "Feature", "properties": { "level_0": 1392926.9667947688, "level_1": 5866808.5014050379, "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E125", "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 893, "elevtn_up": 909.5, "elevtn_dn": 910.4000244140625, "invlev_up": 907.0, "invlev_dn": 907.9000244140625, "where": "upstream", "distance_right": 2.3433279429140186e-07, "nodeid": "1392926.966795_5866808.501405" }, "geometry": { "type": "Point", "coordinates": [ 1392926.966794768813998, 5866808.501405037939548 ] } } ->>>>>>> main +{ "type": "Feature", "properties": { "level_0": 1384118.7186508661, "level_1": 5855518.21493336, "branchtype": "river", "bedlev": 701.4000244140625, "branchid": "river_5", "width": 60.93007025, "height": 15.174972534179688, "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_5", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": 6, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "where": "downstream", "distance_right": 3.8448292198833252e-07, "nodeid": "1384118.718651_5855518.214933" }, "geometry": { "type": "Point", "coordinates": [ 1384118.718650866067037, 5855518.214933359995484 ] } }, +{ "type": "Feature", "properties": { "level_0": 1393846.8667426864, "level_1": 5859166.3015384898, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E140", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 168, "elevtn_up": 1144.300048828125, "elevtn_dn": 1112.5, "invlev_up": 1141.800048828125, "invlev_dn": 1110.0, "where": "downstream", "distance_right": 5.8166784782944824e-07, "nodeid": "1393846.866743_5859166.301538" }, "geometry": { "type": "Point", "coordinates": [ 1393846.866742686368525, 5859166.301538489758968 ] } }, +{ "type": "Feature", "properties": { "level_0": 1386078.4202513243, "level_1": 5859854.3928082353, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1239", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 364, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "where": "downstream", "distance_right": 4.0088765079104887e-07, "nodeid": "1386078.420251_5859854.392808" }, "geometry": { "type": "Point", "coordinates": [ 1386078.420251324307173, 5859854.392808235250413 ] } }, +{ "type": "Feature", "properties": { "level_0": 1386045.2509392484, "level_1": 5859913.8590362957, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E276", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 447, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "where": "downstream", "distance_right": 3.8584702415109949e-07, "nodeid": "1386045.250939_5859913.859036" }, "geometry": { "type": "Point", "coordinates": [ 1386045.250939248362556, 5859913.859036295674741 ] } }, +{ "type": "Feature", "properties": { "level_0": 1384484.1807617808, "level_1": 5857184.3018050948, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_11_E9", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 458, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "where": "downstream", "distance_right": 2.3880128290434959e-07, "nodeid": "1384484.180762_5857184.301805" }, "geometry": { "type": "Point", "coordinates": [ 1384484.18076178082265, 5857184.301805094815791 ] } }, +{ "type": "Feature", "properties": { "level_0": 1384480.7748306419, "level_1": 5857195.2444554009, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_15_E0", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_15", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_15", "diameter": 0.5, "index_right": 467, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "where": "downstream", "distance_right": 5.3722077541611869e-07, "nodeid": "1384480.774831_5857195.244455" }, "geometry": { "type": "Point", "coordinates": [ 1384480.774830641923472, 5857195.244455400854349 ] } }, +{ "type": "Feature", "properties": { "level_0": 1385834.1594623995, "level_1": 5858793.8441787036, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E47", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 519, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "where": "downstream", "distance_right": 4.9733410300668418e-07, "nodeid": "1385834.159462_5858793.844179" }, "geometry": { "type": "Point", "coordinates": [ 1385834.15946239954792, 5858793.844178703613579 ] } }, +{ "type": "Feature", "properties": { "level_0": 1385177.8775195002, "level_1": 5858363.9756671879, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_21_E4", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_21", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 525, "elevtn_up": 758.9000244140625, "elevtn_dn": 756.79998779296875, "invlev_up": 756.4000244140625, "invlev_dn": 754.29998779296875, "where": "downstream", "distance_right": 5.341153742051576e-07, "nodeid": "1385177.877520_5858363.975667" }, "geometry": { "type": "Point", "coordinates": [ 1385177.877519500209019, 5858363.975667187944055 ] } }, +{ "type": "Feature", "properties": { "level_0": 1384799.2182603152, "level_1": 5858488.5922634779, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_23_E1", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_23", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": 0.5, "index_right": 528, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "where": "downstream", "distance_right": 5.7240456036556167e-07, "nodeid": "1384799.218260_5858488.592263" }, "geometry": { "type": "Point", "coordinates": [ 1384799.21826031524688, 5858488.592263477854431 ] } }, +{ "type": "Feature", "properties": { "level_0": 1385472.2180530226, "level_1": 5858925.2730725091, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_25_E2", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_25", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": 0.5, "index_right": 535, "elevtn_up": 791.20001220703125, "elevtn_dn": 783.0, "invlev_up": 788.70001220703125, "invlev_dn": 780.5, "where": "downstream", "distance_right": 4.913263386404469e-07, "nodeid": "1385472.218053_5858925.273073" }, "geometry": { "type": "Point", "coordinates": [ 1385472.218053022632375, 5858925.273072509095073 ] } }, +{ "type": "Feature", "properties": { "level_0": 1388962.2407159139, "level_1": 5860301.717001454, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E73", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 620, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "where": "downstream", "distance_right": 4.6166295054686266e-07, "nodeid": "1388962.240716_5860301.717001" }, "geometry": { "type": "Point", "coordinates": [ 1388962.240715913940221, 5860301.717001453973353 ] } }, +{ "type": "Feature", "properties": { "level_0": 1386273.1738117875, "level_1": 5859335.3654602878, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_33_E12", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 633, "elevtn_up": 717.60003662109375, "elevtn_dn": 711.0, "invlev_up": 715.10003662109375, "invlev_dn": 708.5, "where": "downstream", "distance_right": 3.577770704512787e-07, "nodeid": "1386273.173812_5859335.365460" }, "geometry": { "type": "Point", "coordinates": [ 1386273.173811787506565, 5859335.36546028777957 ] } }, +{ "type": "Feature", "properties": { "level_0": 1387692.1617963261, "level_1": 5866783.4206203762, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_42_E7", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 867, "elevtn_up": 816.10003662109375, "elevtn_dn": 802.4000244140625, "invlev_up": 813.60003662109375, "invlev_dn": 799.9000244140625, "where": "downstream", "distance_right": 4.9781434926194598e-07, "nodeid": "1387692.161796_5866783.420620" }, "geometry": { "type": "Point", "coordinates": [ 1387692.161796326050535, 5866783.420620376244187 ] } }, +{ "type": "Feature", "properties": { "level_0": 1387975.2799954726, "level_1": 5866107.4257222451, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_48_E0", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_48", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_48", "diameter": 0.5, "index_right": 892, "elevtn_up": 803.9000244140625, "elevtn_dn": 786.29998779296875, "invlev_up": 801.4000244140625, "invlev_dn": 783.79998779296875, "where": "downstream", "distance_right": 5.3234291644079913e-07, "nodeid": "1387975.279995_5866107.425722" }, "geometry": { "type": "Point", "coordinates": [ 1387975.279995472636074, 5866107.425722245126963 ] } }, +{ "type": "Feature", "properties": { "level_0": 1393117.0441566666, "level_1": 5866704.0716401814, "branchtype": "river", "bedlev": 849.79998779296875, "branchid": "river_1", "width": 60.500781333333329, "height": 24.5, "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_1", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": 0, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "where": "upstream", "distance_right": 3.7966561587080121e-07, "nodeid": "1393117.044157_5866704.071640" }, "geometry": { "type": "Point", "coordinates": [ 1393117.044156666612253, 5866704.071640181355178 ] } }, +{ "type": "Feature", "properties": { "level_0": 1387829.3683439796, "level_1": 5866704.0716401814, "branchtype": "river", "bedlev": 789.5, "branchid": "river_2", "width": 63.595319, "height": 15.025009155273438, "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_2", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": 2, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "where": "upstream", "distance_right": 1.8276004259190638e-07, "nodeid": "1387829.368344_5866704.071640" }, "geometry": { "type": "Point", "coordinates": [ 1387829.368343979585916, 5866704.071640181355178 ] } }, +{ "type": "Feature", "properties": { "level_0": 1391540.0180370933, "level_1": 5858077.5772200329, "branchtype": "river", "bedlev": 952.79998779296875, "branchid": "river_3", "width": 50.0, "height": 21.70001220703125, "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_3", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": 3, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "where": "upstream", "distance_right": 9.8891646795509848e-08, "nodeid": "1391540.018037_5858077.577220" }, "geometry": { "type": "Point", "coordinates": [ 1391540.018037093337625, 5858077.577220032922924 ] } }, +{ "type": "Feature", "properties": { "level_0": 1388521.2575925963, "level_1": 5855362.0276134778, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1045", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 169, "elevtn_up": 968.29998779296875, "elevtn_dn": 968.29998779296875, "invlev_up": 965.79998779296875, "invlev_dn": 965.79998779296875, "where": "upstream", "distance_right": 6.2550722664998962e-07, "nodeid": "1388521.257593_5855362.027613" }, "geometry": { "type": "Point", "coordinates": [ 1388521.257592596346512, 5855362.027613477781415 ] } }, +{ "type": "Feature", "properties": { "level_0": 1384050.267680947, "level_1": 5856698.7020015484, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E195", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 365, "elevtn_up": 814.29998779296875, "elevtn_dn": 802.9000244140625, "invlev_up": 811.79998779296875, "invlev_dn": 800.4000244140625, "where": "upstream", "distance_right": 4.5480020130277707e-07, "nodeid": "1384050.267681_5856698.702002" }, "geometry": { "type": "Point", "coordinates": [ 1384050.267680946970358, 5856698.702001548372209 ] } }, +{ "type": "Feature", "properties": { "level_0": 1384196.86181646, "level_1": 5856829.8804841097, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_11_E0", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 448, "elevtn_up": 800.79998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 798.29998779296875, "invlev_dn": 798.29998779296875, "where": "upstream", "distance_right": 4.7301652606593837e-07, "nodeid": "1384196.861816_5856829.880484" }, "geometry": { "type": "Point", "coordinates": [ 1384196.861816460033879, 5856829.88048410974443 ] } }, +{ "type": "Feature", "properties": { "level_0": 1384289.0655242952, "level_1": 5856954.9478410175, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_12_E0", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 459, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "where": "upstream", "distance_right": 2.9575907640532436e-07, "nodeid": "1384289.065524_5856954.947841" }, "geometry": { "type": "Point", "coordinates": [ 1384289.06552429520525, 5856954.947841017507017 ] } }, +{ "type": "Feature", "properties": { "level_0": 1384512.4849668304, "level_1": 5857248.8580293376, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E0", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 471, "elevtn_up": 805.0, "elevtn_dn": 796.29998779296875, "invlev_up": 802.5, "invlev_dn": 793.79998779296875, "where": "upstream", "distance_right": 3.7745466738450301e-07, "nodeid": "1384512.484967_5857248.858029" }, "geometry": { "type": "Point", "coordinates": [ 1384512.484966830350459, 5857248.858029337599874 ] } }, +{ "type": "Feature", "properties": { "level_0": 1385352.4717880946, "level_1": 5858398.702550319, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_21_E0", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_21", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 520, "elevtn_up": 756.29998779296875, "elevtn_dn": 765.0, "invlev_up": 753.79998779296875, "invlev_dn": 762.5, "where": "upstream", "distance_right": 3.3313663649888272e-07, "nodeid": "1385352.471788_5858398.702550" }, "geometry": { "type": "Point", "coordinates": [ 1385352.471788094611838, 5858398.70255031902343 ] } }, +{ "type": "Feature", "properties": { "level_0": 1384748.1072519517, "level_1": 5858475.4653943758, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_23_E0", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_23", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": 0.5, "index_right": 526, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "where": "upstream", "distance_right": 3.7932856782999725e-07, "nodeid": "1384748.107252_5858475.465394" }, "geometry": { "type": "Point", "coordinates": [ 1384748.107251951703802, 5858475.46539437584579 ] } }, +{ "type": "Feature", "properties": { "level_0": 1385425.8717415037, "level_1": 5858809.5220389515, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_25_E0", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_25", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": 0.5, "index_right": 532, "elevtn_up": 786.79998779296875, "elevtn_dn": 791.20001220703125, "invlev_up": 784.29998779296875, "invlev_dn": 788.70001220703125, "where": "upstream", "distance_right": 4.9875171671174047e-07, "nodeid": "1385425.871742_5858809.522039" }, "geometry": { "type": "Point", "coordinates": [ 1385425.871741503709927, 5858809.522038951516151 ] } }, +{ "type": "Feature", "properties": { "level_0": 1385861.3725137978, "level_1": 5858893.8325690301, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_29_E0", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_29", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_29", "diameter": 0.5, "index_right": 536, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "where": "upstream", "distance_right": 2.0428258687376185e-07, "nodeid": "1385861.372514_5858893.832569" }, "geometry": { "type": "Point", "coordinates": [ 1385861.372513797832653, 5858893.832569030113518 ] } }, +{ "type": "Feature", "properties": { "level_0": 1387137.2230088995, "level_1": 5858981.7231069598, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_30_E0", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 538, "elevtn_up": 769.4000244140625, "elevtn_dn": 769.4000244140625, "invlev_up": 766.9000244140625, "invlev_dn": 766.9000244140625, "where": "upstream", "distance_right": 1.0826199317136784e-07, "nodeid": "1387137.223009_5858981.723107" }, "geometry": { "type": "Point", "coordinates": [ 1387137.22300889948383, 5858981.723106959834695 ] } }, +{ "type": "Feature", "properties": { "level_0": 1386030.9264584926, "level_1": 5859869.8815911002, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_36_E0", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_36", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_36", "diameter": 0.5, "index_right": 726, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "where": "upstream", "distance_right": 5.0283226172582603e-07, "nodeid": "1386030.926458_5859869.881591" }, "geometry": { "type": "Point", "coordinates": [ 1386030.926458492642269, 5859869.881591100245714 ] } }, +{ "type": "Feature", "properties": { "level_0": 1386043.3811057615, "level_1": 5859908.1192919631, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_37_E0", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_37", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_37", "diameter": 0.5, "index_right": 727, "elevtn_up": 766.29998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 778.29998779296875, "where": "upstream", "distance_right": 2.4131141216608354e-07, "nodeid": "1386043.381106_5859908.119292" }, "geometry": { "type": "Point", "coordinates": [ 1386043.381105761509389, 5859908.11929196305573 ] } }, +{ "type": "Feature", "properties": { "level_0": 1387931.6147025716, "level_1": 5866170.5421204576, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_45_E0", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_45", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": 0.5, "index_right": 878, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "where": "upstream", "distance_right": 6.266084733821659e-07, "nodeid": "1387931.614703_5866170.542120" }, "geometry": { "type": "Point", "coordinates": [ 1387931.614702571649104, 5866170.542120457626879 ] } }, +{ "type": "Feature", "properties": { "level_0": 1387940.4436740221, "level_1": 5865845.0932547273, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_47_E0", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_47", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 886, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "where": "upstream", "distance_right": 2.7377250423463006e-07, "nodeid": "1387940.443674_5865845.093255" }, "geometry": { "type": "Point", "coordinates": [ 1387940.443674022099003, 5865845.093254727311432 ] } }, +{ "type": "Feature", "properties": { "level_0": 1392926.9667947688, "level_1": 5866808.5014050379, "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E125", "width": null, "height": null, "branchorder": -1.0, "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 893, "elevtn_up": 909.5, "elevtn_dn": 910.4000244140625, "invlev_up": 907.0, "invlev_dn": 907.9000244140625, "where": "upstream", "distance_right": 2.3433279429140186e-07, "nodeid": "1392926.966795_5866808.501405" }, "geometry": { "type": "Point", "coordinates": [ 1392926.966794768813998, 5866808.501405037939548 ] } } ] } diff --git a/examples/dflowfm_piave/geoms/branches.geojson b/examples/dflowfm_piave/geoms/branches.geojson index 8351ad83..312b5100 100644 --- a/examples/dflowfm_piave/geoms/branches.geojson +++ b/examples/dflowfm_piave/geoms/branches.geojson @@ -2,2022 +2,1012 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::3857" } }, "features": [ -<<<<<<< HEAD -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_1_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389238.298387300921604, 5860147.714495398104191 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 933.5, "invlev_up": 913.4000244140625, "invlev_dn": 931.0, "manhole_up": "manhole_1_generated", "manhole_dn": "manhole_2_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389238.298387300921604, 5860147.714495398104191 ], [ 1389210.947846550960094, 5860184.343885350972414 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.5, "elevtn_dn": 933.5, "invlev_up": 931.0, "invlev_dn": 931.0, "manhole_up": "manhole_2_generated", "manhole_dn": "manhole_3_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389210.947846550960094, 5860184.343885350972414 ], [ 1389186.961922727525234, 5860223.315261371433735 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.5, "elevtn_dn": 935.5, "invlev_up": 931.0, "invlev_dn": 933.0, "manhole_up": "manhole_3_generated", "manhole_dn": "manhole_4_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389186.961922727525234, 5860223.315261371433735 ], [ 1389162.755598766496405, 5860262.142883376218379 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 935.5, "invlev_up": 933.0, "invlev_dn": 933.0, "manhole_up": "manhole_4_generated", "manhole_dn": "manhole_5_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389162.755598766496405, 5860262.142883376218379 ], [ 1389136.759307563304901, 5860299.80301527120173 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 936.5, "invlev_up": 933.0, "invlev_dn": 934.0, "manhole_up": "manhole_5_generated", "manhole_dn": "manhole_6_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389136.759307563304901, 5860299.80301527120173 ], [ 1389109.7301227634307, 5860336.652257356792688 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 936.5, "elevtn_dn": 941.10003662109375, "invlev_up": 934.0, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_6_generated", "manhole_dn": "manhole_7_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389109.7301227634307, 5860336.652257356792688 ], [ 1389073.18478828552179, 5860363.522737024351954 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_7_generated", "manhole_dn": "manhole_8_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389073.18478828552179, 5860363.522737024351954 ], [ 1389032.546542100608349, 5860384.329287325032055 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_8_generated", "manhole_dn": "manhole_9_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389032.546542100608349, 5860384.329287325032055 ], [ 1388989.578410296700895, 5860400.071978960186243 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 951.29998779296875, "invlev_up": 938.60003662109375, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_9_generated", "manhole_dn": "manhole_10_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388989.578410296700895, 5860400.071978960186243 ], [ 1388946.301100668497384, 5860414.883977899327874 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_11_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389221.905703959986567, 5860123.3256367566064 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_11_generated", "manhole_dn": "manhole_12_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389221.905703959986567, 5860123.3256367566064 ], [ 1389177.295895804418251, 5860134.962970778346062 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 919.60003662109375, "invlev_up": 913.4000244140625, "invlev_dn": 917.10003662109375, "manhole_up": "manhole_12_generated", "manhole_dn": "manhole_13_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389177.295895804418251, 5860134.962970778346062 ], [ 1389132.686087648617104, 5860146.600304800085723 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 919.60003662109375, "elevtn_dn": 919.60003662109375, "invlev_up": 917.10003662109375, "invlev_dn": 917.10003662109375, "manhole_up": "manhole_13_generated", "manhole_dn": "manhole_14_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389132.686087648617104, 5860146.600304800085723 ], [ 1389088.076279493048787, 5860158.237638821825385 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 919.60003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 917.10003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_14_generated", "manhole_dn": "manhole_15_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389088.076279493048787, 5860158.237638821825385 ], [ 1389044.226173994829878, 5860172.143308508209884 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 935.60003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_15_generated", "manhole_dn": "manhole_16_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389044.226173994829878, 5860172.143308508209884 ], [ 1389012.527182487538084, 5860198.239755615592003 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 935.60003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_16_generated", "manhole_dn": "manhole_17_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389012.527182487538084, 5860198.239755615592003 ], [ 1388995.773122631013393, 5860240.481283166445792 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 945.0, "invlev_up": 935.60003662109375, "invlev_dn": 942.5, "manhole_up": "manhole_17_generated", "manhole_dn": "manhole_18_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388995.773122631013393, 5860240.481283166445792 ], [ 1388973.630034049740061, 5860280.918223639950156 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.0, "elevtn_dn": 951.29998779296875, "invlev_up": 942.5, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_18_generated", "manhole_dn": "manhole_19_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388973.630034049740061, 5860280.918223639950156 ], [ 1388961.171157888136804, 5860324.081192856654525 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_19_generated", "manhole_dn": "manhole_20_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388961.171157888136804, 5860324.081192856654525 ], [ 1388955.410555170848966, 5860369.690168970264494 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_20_generated", "manhole_dn": "manhole_10_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388955.410555170848966, 5860369.690168970264494 ], [ 1388946.301100668497384, 5860414.883977899327874 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 914.5, "invlev_up": 913.4000244140625, "invlev_dn": 912.0, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_21_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389306.50000010849908, 5860083.476415127515793 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 914.5, "elevtn_dn": 914.5, "invlev_up": 912.0, "invlev_dn": 912.0, "manhole_up": "manhole_21_generated", "manhole_dn": "manhole_22_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389306.50000010849908, 5860083.476415127515793 ], [ 1389355.420758404070511, 5860074.630405306816101 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 914.5, "elevtn_dn": 929.9000244140625, "invlev_up": 912.0, "invlev_dn": 927.4000244140625, "manhole_up": "manhole_22_generated", "manhole_dn": "manhole_23_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389355.420758404070511, 5860074.630405306816101 ], [ 1389389.090761042200029, 5860042.4449307853356 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 929.9000244140625, "elevtn_dn": 955.0, "invlev_up": 927.4000244140625, "invlev_dn": 952.5, "manhole_up": "manhole_23_generated", "manhole_dn": "manhole_24_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389389.090761042200029, 5860042.4449307853356 ], [ 1389404.036260401364416, 5859994.775433851405978 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_24_generated", "manhole_dn": "manhole_25_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389404.036260401364416, 5859994.775433851405978 ], [ 1389418.744130451697856, 5859947.032028519548476 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_25_generated", "manhole_dn": "manhole_26_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389418.744130451697856, 5859947.032028519548476 ], [ 1389423.265342897269875, 5859897.853969652205706 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 975.29998779296875, "invlev_up": 952.5, "invlev_dn": 972.79998779296875, "manhole_up": "manhole_26_generated", "manhole_dn": "manhole_27_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389423.265342897269875, 5859897.853969652205706 ], [ 1389395.831073811277747, 5859856.743154510855675 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 975.29998779296875, "elevtn_dn": 963.0, "invlev_up": 972.79998779296875, "invlev_dn": 960.5, "manhole_up": "manhole_27_generated", "manhole_dn": "manhole_28_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389395.831073811277747, 5859856.743154510855675 ], [ 1389350.827042841585353, 5859839.640478814020753 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 963.0, "elevtn_dn": 963.0, "invlev_up": 960.5, "invlev_dn": 960.5, "manhole_up": "manhole_28_generated", "manhole_dn": "manhole_29_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389350.827042841585353, 5859839.640478814020753 ], [ 1389303.795788601972163, 5859855.887689013034105 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 963.0, "elevtn_dn": 945.4000244140625, "invlev_up": 960.5, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_29_generated", "manhole_dn": "manhole_30_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389303.795788601972163, 5859855.887689013034105 ], [ 1389256.284586790716276, 5859863.631580747663975 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 945.4000244140625, "invlev_up": 942.9000244140625, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_30_generated", "manhole_dn": "manhole_31_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389256.284586790716276, 5859863.631580747663975 ], [ 1389227.308454349869862, 5859823.781623384915292 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 945.4000244140625, "invlev_up": 942.9000244140625, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_31_generated", "manhole_dn": "manhole_32_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389227.308454349869862, 5859823.781623384915292 ], [ 1389202.745489193825051, 5859780.279727600514889 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 959.10003662109375, "invlev_up": 942.9000244140625, "invlev_dn": 956.60003662109375, "manhole_up": "manhole_32_generated", "manhole_dn": "manhole_33_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389202.745489193825051, 5859780.279727600514889 ], [ 1389178.18252403778024, 5859736.777831817045808 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 959.10003662109375, "elevtn_dn": 944.79998779296875, "invlev_up": 956.60003662109375, "invlev_dn": 942.29998779296875, "manhole_up": "manhole_33_generated", "manhole_dn": "manhole_34_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389178.18252403778024, 5859736.777831817045808 ], [ 1389155.231297271326184, 5859692.450142606161535 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 944.79998779296875, "elevtn_dn": 944.79998779296875, "invlev_up": 942.29998779296875, "invlev_dn": 942.29998779296875, "manhole_up": "manhole_34_generated", "manhole_dn": "manhole_35_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389155.231297271326184, 5859692.450142606161535 ], [ 1389141.413412723457441, 5859644.883844587020576 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 944.79998779296875, "elevtn_dn": 952.4000244140625, "invlev_up": 942.29998779296875, "invlev_dn": 949.9000244140625, "manhole_up": "manhole_35_generated", "manhole_dn": "manhole_36_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389141.413412723457441, 5859644.883844587020576 ], [ 1389151.802280035568401, 5859598.61804121825844 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.4000244140625, "elevtn_dn": 960.70001220703125, "invlev_up": 949.9000244140625, "invlev_dn": 958.20001220703125, "manhole_up": "manhole_36_generated", "manhole_dn": "manhole_37_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389151.802280035568401, 5859598.61804121825844 ], [ 1389191.073854762827978, 5859569.046822287142277 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 960.70001220703125, "elevtn_dn": 960.70001220703125, "invlev_up": 958.20001220703125, "invlev_dn": 958.20001220703125, "manhole_up": "manhole_37_generated", "manhole_dn": "manhole_38_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389191.073854762827978, 5859569.046822287142277 ], [ 1389239.915165816899389, 5859563.955490378662944 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 960.70001220703125, "elevtn_dn": 969.60003662109375, "invlev_up": 958.20001220703125, "invlev_dn": 967.10003662109375, "manhole_up": "manhole_38_generated", "manhole_dn": "manhole_39_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389239.915165816899389, 5859563.955490378662944 ], [ 1389289.757686472963542, 5859566.285022127442062 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 969.60003662109375, "elevtn_dn": 969.60003662109375, "invlev_up": 967.10003662109375, "invlev_dn": 967.10003662109375, "manhole_up": "manhole_39_generated", "manhole_dn": "manhole_40_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389289.757686472963542, 5859566.285022127442062 ], [ 1389339.615828452631831, 5859566.079234052449465 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 969.60003662109375, "elevtn_dn": 976.29998779296875, "invlev_up": 967.10003662109375, "invlev_dn": 973.79998779296875, "manhole_up": "manhole_40_generated", "manhole_dn": "manhole_41_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389339.615828452631831, 5859566.079234052449465 ], [ 1389387.354307833593339, 5859551.676988741382957 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 976.29998779296875, "elevtn_dn": 976.29998779296875, "invlev_up": 973.79998779296875, "invlev_dn": 973.79998779296875, "manhole_up": "manhole_41_generated", "manhole_dn": "manhole_42_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389387.354307833593339, 5859551.676988741382957 ], [ 1389428.692968821851537, 5859524.248876142315567 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 976.29998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 973.79998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_42_generated", "manhole_dn": "manhole_43_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389428.692968821851537, 5859524.248876142315567 ], [ 1389461.138921525795013, 5859486.477508954703808 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_43_generated", "manhole_dn": "manhole_44_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389461.138921525795013, 5859486.477508954703808 ], [ 1389482.45163832209073, 5859441.487986368127167 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_44_generated", "manhole_dn": "manhole_45_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389482.45163832209073, 5859441.487986368127167 ], [ 1389497.215460168197751, 5859393.906833835877478 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_45_generated", "manhole_dn": "manhole_46_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389497.215460168197751, 5859393.906833835877478 ], [ 1389508.394423164660111, 5859345.216126504354179 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 954.79998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_46_generated", "manhole_dn": "manhole_47_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389508.394423164660111, 5859345.216126504354179 ], [ 1389518.522437864448875, 5859296.29671473056078 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 954.79998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_47_generated", "manhole_dn": "manhole_48_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389518.522437864448875, 5859296.29671473056078 ], [ 1389528.588071504374966, 5859247.363727764226496 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 950.20001220703125, "invlev_up": 954.79998779296875, "invlev_dn": 947.70001220703125, "manhole_up": "manhole_48_generated", "manhole_dn": "manhole_49_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389528.588071504374966, 5859247.363727764226496 ], [ 1389538.653705144301057, 5859198.43074079696089 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 950.20001220703125, "elevtn_dn": 957.60003662109375, "invlev_up": 947.70001220703125, "invlev_dn": 955.10003662109375, "manhole_up": "manhole_49_generated", "manhole_dn": "manhole_50_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389538.653705144301057, 5859198.43074079696089 ], [ 1389548.719338784459978, 5859149.497753830626607 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.60003662109375, "elevtn_dn": 957.60003662109375, "invlev_up": 955.10003662109375, "invlev_dn": 955.10003662109375, "manhole_up": "manhole_50_generated", "manhole_dn": "manhole_51_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389548.719338784459978, 5859149.497753830626607 ], [ 1389558.784972424386069, 5859100.564766863361001 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.60003662109375, "elevtn_dn": 954.79998779296875, "invlev_up": 955.10003662109375, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_51_generated", "manhole_dn": "manhole_52_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389558.784972424386069, 5859100.564766863361001 ], [ 1389568.85060606431216, 5859051.631779897026718 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 954.79998779296875, "invlev_up": 952.29998779296875, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_52_generated", "manhole_dn": "manhole_53_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389568.85060606431216, 5859051.631779897026718 ], [ 1389578.916239704471081, 5859002.698792929761112 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 954.79998779296875, "invlev_up": 952.29998779296875, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_53_generated", "manhole_dn": "manhole_54_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389578.916239704471081, 5859002.698792929761112 ], [ 1389588.981873344397172, 5858953.765805963426828 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 956.10003662109375, "invlev_up": 952.29998779296875, "invlev_dn": 953.60003662109375, "manhole_up": "manhole_54_generated", "manhole_dn": "manhole_55_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389588.981873344397172, 5858953.765805963426828 ], [ 1389599.047506984323263, 5858904.832818996161222 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 956.10003662109375, "elevtn_dn": 956.10003662109375, "invlev_up": 953.60003662109375, "invlev_dn": 953.60003662109375, "manhole_up": "manhole_55_generated", "manhole_dn": "manhole_56_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389599.047506984323263, 5858904.832818996161222 ], [ 1389613.243873829254881, 5858857.048414096236229 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 956.10003662109375, "elevtn_dn": 966.29998779296875, "invlev_up": 953.60003662109375, "invlev_dn": 963.79998779296875, "manhole_up": "manhole_56_generated", "manhole_dn": "manhole_57_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389613.243873829254881, 5858857.048414096236229 ], [ 1389631.198101107496768, 5858810.554778259247541 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 966.29998779296875, "elevtn_dn": 968.70001220703125, "invlev_up": 963.79998779296875, "invlev_dn": 966.20001220703125, "manhole_up": "manhole_57_generated", "manhole_dn": "manhole_58_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389631.198101107496768, 5858810.554778259247541 ], [ 1389656.490605737781152, 5858767.472956065088511 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.70001220703125, "elevtn_dn": 968.70001220703125, "invlev_up": 966.20001220703125, "invlev_dn": 966.20001220703125, "manhole_up": "manhole_58_generated", "manhole_dn": "manhole_59_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389656.490605737781152, 5858767.472956065088511 ], [ 1389681.956975018838421, 5858724.49639992788434 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.70001220703125, "elevtn_dn": 976.10003662109375, "invlev_up": 966.20001220703125, "invlev_dn": 973.60003662109375, "manhole_up": "manhole_59_generated", "manhole_dn": "manhole_60_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389681.956975018838421, 5858724.49639992788434 ], [ 1389708.407580326776952, 5858682.115747822448611 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 976.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 973.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_60_generated", "manhole_dn": "manhole_61_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389708.407580326776952, 5858682.115747822448611 ], [ 1389734.858185634715483, 5858639.735095717012882 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 980.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_61_generated", "manhole_dn": "manhole_62_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389734.858185634715483, 5858639.735095717012882 ], [ 1389761.308790942654014, 5858597.354443610645831 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 980.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_62_generated", "manhole_dn": "manhole_63_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389761.308790942654014, 5858597.354443610645831 ], [ 1389787.759396250825375, 5858554.973791505210102 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 993.29998779296875, "invlev_up": 980.60003662109375, "invlev_dn": 990.79998779296875, "manhole_up": "manhole_63_generated", "manhole_dn": "manhole_64_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389787.759396250825375, 5858554.973791505210102 ], [ 1389814.210001558763906, 5858512.593139399774373 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 993.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 990.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_64_generated", "manhole_dn": "manhole_65_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389814.210001558763906, 5858512.593139399774373 ], [ 1389840.660606866702437, 5858470.212487293407321 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 995.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_65_generated", "manhole_dn": "manhole_66_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389840.660606866702437, 5858470.212487293407321 ], [ 1389867.111212174640968, 5858427.831835187971592 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 995.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_66_generated", "manhole_dn": "manhole_67_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389867.111212174640968, 5858427.831835187971592 ], [ 1389911.240854029776528, 5858417.074701879173517 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 1006.2000122070312, "invlev_up": 995.79998779296875, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_67_generated", "manhole_dn": "manhole_68_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389911.240854029776528, 5858417.074701879173517 ], [ 1389940.226093058940023, 5858455.739661679603159 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E48", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1006.2000122070312, "invlev_up": 1003.7000122070312, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_68_generated", "manhole_dn": "manhole_69_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389940.226093058940023, 5858455.739661679603159 ], [ 1389959.842267287895083, 5858501.684845351614058 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E49", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1006.2000122070312, "invlev_up": 1003.7000122070312, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_69_generated", "manhole_dn": "manhole_70_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389959.842267287895083, 5858501.684845351614058 ], [ 1389983.028926897095516, 5858544.760824581608176 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E50", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1036.9000244140625, "invlev_up": 1003.7000122070312, "invlev_dn": 1034.4000244140625, "manhole_up": "manhole_70_generated", "manhole_dn": "manhole_71_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389983.028926897095516, 5858544.760824581608176 ], [ 1390026.879799408372492, 5858567.986969069577754 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E51", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1036.9000244140625, "elevtn_dn": 1036.9000244140625, "invlev_up": 1034.4000244140625, "invlev_dn": 1034.4000244140625, "manhole_up": "manhole_71_generated", "manhole_dn": "manhole_72_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390026.879799408372492, 5858567.986969069577754 ], [ 1390075.455719914287329, 5858577.981817713007331 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E52", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1036.9000244140625, "elevtn_dn": 1032.9000244140625, "invlev_up": 1034.4000244140625, "invlev_dn": 1030.4000244140625, "manhole_up": "manhole_72_generated", "manhole_dn": "manhole_73_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390075.455719914287329, 5858577.981817713007331 ], [ 1390124.934819511603564, 5858584.860858413390815 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E53", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1032.9000244140625, "elevtn_dn": 1032.9000244140625, "invlev_up": 1030.4000244140625, "invlev_dn": 1030.4000244140625, "manhole_up": "manhole_73_generated", "manhole_dn": "manhole_74_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390124.934819511603564, 5858584.860858413390815 ], [ 1390174.385966305155307, 5858591.894069475121796 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E54", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1032.9000244140625, "elevtn_dn": 1016.6000366210938, "invlev_up": 1030.4000244140625, "invlev_dn": 1014.1000366210938, "manhole_up": "manhole_74_generated", "manhole_dn": "manhole_75_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390174.385966305155307, 5858591.894069475121796 ], [ 1390224.28731826832518, 5858594.262458441779017 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E55", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1016.6000366210938, "elevtn_dn": 1016.6000366210938, "invlev_up": 1014.1000366210938, "invlev_dn": 1014.1000366210938, "manhole_up": "manhole_75_generated", "manhole_dn": "manhole_76_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390224.28731826832518, 5858594.262458441779017 ], [ 1390273.630285855382681, 5858589.561945637688041 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E56", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1016.6000366210938, "elevtn_dn": 1012.1000366210938, "invlev_up": 1014.1000366210938, "invlev_dn": 1009.6000366210938, "manhole_up": "manhole_76_generated", "manhole_dn": "manhole_77_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390273.630285855382681, 5858589.561945637688041 ], [ 1390322.239480242831632, 5858578.072306710295379 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E57", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1012.1000366210938, "elevtn_dn": 1012.1000366210938, "invlev_up": 1009.6000366210938, "invlev_dn": 1009.6000366210938, "manhole_up": "manhole_77_generated", "manhole_dn": "manhole_78_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390322.239480242831632, 5858578.072306710295379 ], [ 1390371.99352877959609, 5858575.309522898867726 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E58", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1012.1000366210938, "elevtn_dn": 1011.7000122070312, "invlev_up": 1009.6000366210938, "invlev_dn": 1009.2000122070312, "manhole_up": "manhole_78_generated", "manhole_dn": "manhole_79_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390371.99352877959609, 5858575.309522898867726 ], [ 1390419.13544210139662, 5858559.59311543405056 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E59", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1011.7000122070312, "elevtn_dn": 981.5, "invlev_up": 1009.2000122070312, "invlev_dn": 979.0, "manhole_up": "manhole_79_generated", "manhole_dn": "manhole_80_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390419.13544210139662, 5858559.59311543405056 ], [ 1390453.401623640675098, 5858524.246223840862513 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E60", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 981.5, "elevtn_dn": 995.70001220703125, "invlev_up": 979.0, "invlev_dn": 993.20001220703125, "manhole_up": "manhole_80_generated", "manhole_dn": "manhole_81_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390453.401623640675098, 5858524.246223840862513 ], [ 1390496.749499944737181, 5858504.780008735135198 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E61", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 995.70001220703125, "elevtn_dn": 995.70001220703125, "invlev_up": 993.20001220703125, "invlev_dn": 993.20001220703125, "manhole_up": "manhole_81_generated", "manhole_dn": "manhole_82_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390496.749499944737181, 5858504.780008735135198 ], [ 1390546.470755147282034, 5858499.993151630274951 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E62", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 995.70001220703125, "elevtn_dn": 1005.9000244140625, "invlev_up": 993.20001220703125, "invlev_dn": 1003.4000244140625, "manhole_up": "manhole_82_generated", "manhole_dn": "manhole_83_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390546.470755147282034, 5858499.993151630274951 ], [ 1390596.395264241611585, 5858498.177226040512323 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E63", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1005.9000244140625, "elevtn_dn": 1005.9000244140625, "invlev_up": 1003.4000244140625, "invlev_dn": 1003.4000244140625, "manhole_up": "manhole_83_generated", "manhole_dn": "manhole_84_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390596.395264241611585, 5858498.177226040512323 ], [ 1390646.319773336173967, 5858496.361300451681018 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E64", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1005.9000244140625, "elevtn_dn": 1013.6000366210938, "invlev_up": 1003.4000244140625, "invlev_dn": 1011.1000366210938, "manhole_up": "manhole_84_generated", "manhole_dn": "manhole_85_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390646.319773336173967, 5858496.361300451681018 ], [ 1390696.244282430503517, 5858494.545374862849712 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E65", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1013.6000366210938, "elevtn_dn": 1013.6000366210938, "invlev_up": 1011.1000366210938, "invlev_dn": 1011.1000366210938, "manhole_up": "manhole_85_generated", "manhole_dn": "manhole_86_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390696.244282430503517, 5858494.545374862849712 ], [ 1390746.168791524833068, 5858492.729449273087084 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E66", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1013.6000366210938, "elevtn_dn": 1019.1000366210938, "invlev_up": 1011.1000366210938, "invlev_dn": 1016.6000366210938, "manhole_up": "manhole_86_generated", "manhole_dn": "manhole_87_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390746.168791524833068, 5858492.729449273087084 ], [ 1390796.09330061939545, 5858490.913523684255779 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E67", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1019.1000366210938, "elevtn_dn": 1025.800048828125, "invlev_up": 1016.6000366210938, "invlev_dn": 1023.300048828125, "manhole_up": "manhole_87_generated", "manhole_dn": "manhole_88_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390796.09330061939545, 5858490.913523684255779 ], [ 1390846.017809713725001, 5858489.097598095424473 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E68", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1025.800048828125, "elevtn_dn": 1025.800048828125, "invlev_up": 1023.300048828125, "invlev_dn": 1023.300048828125, "manhole_up": "manhole_88_generated", "manhole_dn": "manhole_89_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390846.017809713725001, 5858489.097598095424473 ], [ 1390895.942318808054551, 5858487.281672505661845 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E69", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1025.800048828125, "elevtn_dn": 1029.2000732421875, "invlev_up": 1023.300048828125, "invlev_dn": 1026.7000732421875, "manhole_up": "manhole_89_generated", "manhole_dn": "manhole_90_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390895.942318808054551, 5858487.281672505661845 ], [ 1390945.364988021552563, 5858492.061225635930896 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E70", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1029.2000732421875, "elevtn_dn": 1029.2000732421875, "invlev_up": 1026.7000732421875, "invlev_dn": 1026.7000732421875, "manhole_up": "manhole_90_generated", "manhole_dn": "manhole_91_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390945.364988021552563, 5858492.061225635930896 ], [ 1390994.440001817885786, 5858501.409873396158218 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E71", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1029.2000732421875, "elevtn_dn": 1033.2000732421875, "invlev_up": 1026.7000732421875, "invlev_dn": 1030.7000732421875, "manhole_up": "manhole_91_generated", "manhole_dn": "manhole_92_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390994.440001817885786, 5858501.409873396158218 ], [ 1391040.341196772176772, 5858520.979841153137386 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E72", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1033.2000732421875, "elevtn_dn": 1033.2000732421875, "invlev_up": 1030.7000732421875, "invlev_dn": 1030.7000732421875, "manhole_up": "manhole_92_generated", "manhole_dn": "manhole_93_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391040.341196772176772, 5858520.979841153137386 ], [ 1391086.683747049886733, 5858538.717575071379542 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E73", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1033.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1030.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_93_generated", "manhole_dn": "manhole_94_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391086.683747049886733, 5858538.717575071379542 ], [ 1391131.822940095094964, 5858523.93243224080652 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E74", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_94_generated", "manhole_dn": "manhole_95_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391131.822940095094964, 5858523.93243224080652 ], [ 1391153.157672074623406, 5858479.460670891217887 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E75", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_95_generated", "manhole_dn": "manhole_96_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391153.157672074623406, 5858479.460670891217887 ], [ 1391192.49590603238903, 5858451.67839205916971 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E76", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1044.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1041.7000732421875, "manhole_up": "manhole_96_generated", "manhole_dn": "manhole_97_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391192.49590603238903, 5858451.67839205916971 ], [ 1391240.64117361814715, 5858438.460245226509869 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E77", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1044.2000732421875, "elevtn_dn": 1044.2000732421875, "invlev_up": 1041.7000732421875, "invlev_dn": 1041.7000732421875, "manhole_up": "manhole_97_generated", "manhole_dn": "manhole_98_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391240.64117361814715, 5858438.460245226509869 ], [ 1391289.211760010803118, 5858426.770406410098076 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E78", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1044.2000732421875, "elevtn_dn": 1060.0999755859375, "invlev_up": 1041.7000732421875, "invlev_dn": 1057.5999755859375, "manhole_up": "manhole_98_generated", "manhole_dn": "manhole_99_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391289.211760010803118, 5858426.770406410098076 ], [ 1391337.782346403226256, 5858415.080567593686283 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E79", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1060.0999755859375, "elevtn_dn": 1023.0, "invlev_up": 1057.5999755859375, "invlev_dn": 1020.5, "manhole_up": "manhole_99_generated", "manhole_dn": "manhole_100_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391337.782346403226256, 5858415.080567593686283 ], [ 1391386.352932795882225, 5858403.390728777274489 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E80", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1023.0, "elevtn_dn": 1032.7000732421875, "invlev_up": 1020.5, "invlev_dn": 1030.2000732421875, "manhole_up": "manhole_100_generated", "manhole_dn": "manhole_101_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391386.352932795882225, 5858403.390728777274489 ], [ 1391434.923519188305363, 5858391.700889961794019 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E81", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1032.7000732421875, "elevtn_dn": 1032.7000732421875, "invlev_up": 1030.2000732421875, "invlev_dn": 1030.2000732421875, "manhole_up": "manhole_101_generated", "manhole_dn": "manhole_102_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391434.923519188305363, 5858391.700889961794019 ], [ 1391483.494105580961332, 5858380.011051145382226 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E82", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1032.7000732421875, "elevtn_dn": 1040.7000732421875, "invlev_up": 1030.2000732421875, "invlev_dn": 1038.2000732421875, "manhole_up": "manhole_102_generated", "manhole_dn": "manhole_103_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391483.494105580961332, 5858380.011051145382226 ], [ 1391532.464345134794712, 5858375.802092345431447 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E83", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1040.7000732421875, "elevtn_dn": 1040.7000732421875, "invlev_up": 1038.2000732421875, "invlev_dn": 1038.2000732421875, "manhole_up": "manhole_103_generated", "manhole_dn": "manhole_104_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391532.464345134794712, 5858375.802092345431447 ], [ 1391579.680508555145934, 5858389.753166117705405 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E84", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1040.7000732421875, "elevtn_dn": 1094.5999755859375, "invlev_up": 1038.2000732421875, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_104_generated", "manhole_dn": "manhole_105_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391579.680508555145934, 5858389.753166117705405 ], [ 1391615.043221722124144, 5858422.374543751589954 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E85", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1094.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_105_generated", "manhole_dn": "manhole_106_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391615.043221722124144, 5858422.374543751589954 ], [ 1391633.654095822479576, 5858468.206737855449319 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E86", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1094.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_106_generated", "manhole_dn": "manhole_107_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391633.654095822479576, 5858468.206737855449319 ], [ 1391675.556871910346672, 5858492.042518986389041 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E87", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1100.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1098.0999755859375, "manhole_up": "manhole_107_generated", "manhole_dn": "manhole_108_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391675.556871910346672, 5858492.042518986389041 ], [ 1391725.165284683462232, 5858493.223410680890083 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E88", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1100.5999755859375, "elevtn_dn": 1092.7000732421875, "invlev_up": 1098.0999755859375, "invlev_dn": 1090.2000732421875, "manhole_up": "manhole_108_generated", "manhole_dn": "manhole_109_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391725.165284683462232, 5858493.223410680890083 ], [ 1391774.025632579578087, 5858482.968163449317217 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E89", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1092.7000732421875, "elevtn_dn": 1092.7000732421875, "invlev_up": 1090.2000732421875, "invlev_dn": 1090.2000732421875, "manhole_up": "manhole_109_generated", "manhole_dn": "manhole_110_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391774.025632579578087, 5858482.968163449317217 ], [ 1391822.748904443578795, 5858472.800456050783396 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E90", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1092.7000732421875, "elevtn_dn": 1086.5, "invlev_up": 1090.2000732421875, "invlev_dn": 1084.0, "manhole_up": "manhole_110_generated", "manhole_dn": "manhole_111_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391822.748904443578795, 5858472.800456050783396 ], [ 1391872.520155652426183, 5858474.254766616038978 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E91", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1086.5, "elevtn_dn": 1086.5, "invlev_up": 1084.0, "invlev_dn": 1084.0, "manhole_up": "manhole_111_generated", "manhole_dn": "manhole_112_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391872.520155652426183, 5858474.254766616038978 ], [ 1391922.32820742437616, 5858478.116394865326583 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E92", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1086.5, "elevtn_dn": 1097.300048828125, "invlev_up": 1084.0, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_112_generated", "manhole_dn": "manhole_113_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391922.32820742437616, 5858478.116394865326583 ], [ 1391972.136259196558967, 5858481.978023114614189 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E93", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_113_generated", "manhole_dn": "manhole_114_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391972.136259196558967, 5858481.978023114614189 ], [ 1392014.088137687649578, 5858507.265420926734805 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E94", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_114_generated", "manhole_dn": "manhole_115_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392014.088137687649578, 5858507.265420926734805 ], [ 1392052.00577615830116, 5858538.949620860628784 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E95", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_115_generated", "manhole_dn": "manhole_116_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392052.00577615830116, 5858538.949620860628784 ], [ 1392100.993319420609623, 5858548.746293722651899 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E96", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1135.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1132.800048828125, "manhole_up": "manhole_116_generated", "manhole_dn": "manhole_117_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392100.993319420609623, 5858548.746293722651899 ], [ 1392149.980862683150917, 5858558.542966585606337 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E97", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1135.300048828125, "elevtn_dn": 1135.300048828125, "invlev_up": 1132.800048828125, "invlev_dn": 1132.800048828125, "manhole_up": "manhole_117_generated", "manhole_dn": "manhole_118_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392149.980862683150917, 5858558.542966585606337 ], [ 1392198.767287699971348, 5858569.25206732749939 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E98", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1135.300048828125, "elevtn_dn": 1137.5999755859375, "invlev_up": 1132.800048828125, "invlev_dn": 1135.0999755859375, "manhole_up": "manhole_118_generated", "manhole_dn": "manhole_119_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392198.767287699971348, 5858569.25206732749939 ], [ 1392247.333906656363979, 5858580.958378325216472 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E99", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1137.5999755859375, "elevtn_dn": 1137.5999755859375, "invlev_up": 1135.0999755859375, "invlev_dn": 1135.0999755859375, "manhole_up": "manhole_119_generated", "manhole_dn": "manhole_120_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392247.333906656363979, 5858580.958378325216472 ], [ 1392295.900525612989441, 5858592.664689323864877 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E100", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1137.5999755859375, "elevtn_dn": 1145.0999755859375, "invlev_up": 1135.0999755859375, "invlev_dn": 1142.5999755859375, "manhole_up": "manhole_120_generated", "manhole_dn": "manhole_121_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392295.900525612989441, 5858592.664689323864877 ], [ 1392344.467144569614902, 5858604.371000322513282 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E101", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1145.0999755859375, "elevtn_dn": 1145.0999755859375, "invlev_up": 1142.5999755859375, "invlev_dn": 1142.5999755859375, "manhole_up": "manhole_121_generated", "manhole_dn": "manhole_122_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392344.467144569614902, 5858604.371000322513282 ], [ 1392389.908255772199482, 5858624.575613909401 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E102", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1145.0999755859375, "elevtn_dn": 1140.5, "invlev_up": 1142.5999755859375, "invlev_dn": 1138.0, "manhole_up": "manhole_122_generated", "manhole_dn": "manhole_123_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392389.908255772199482, 5858624.575613909401 ], [ 1392425.081700494978577, 5858659.315580372698605 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E103", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1140.5, "elevtn_dn": 1169.300048828125, "invlev_up": 1138.0, "invlev_dn": 1166.800048828125, "manhole_up": "manhole_123_generated", "manhole_dn": "manhole_124_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392425.081700494978577, 5858659.315580372698605 ], [ 1392458.203119478421286, 5858696.715123130939901 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E104", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.300048828125, "elevtn_dn": 1169.300048828125, "invlev_up": 1166.800048828125, "invlev_dn": 1166.800048828125, "manhole_up": "manhole_124_generated", "manhole_dn": "manhole_125_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392458.203119478421286, 5858696.715123130939901 ], [ 1392491.324538461863995, 5858734.114665890112519 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E105", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.300048828125, "elevtn_dn": 1165.5, "invlev_up": 1166.800048828125, "invlev_dn": 1163.0, "manhole_up": "manhole_125_generated", "manhole_dn": "manhole_126_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392491.324538461863995, 5858734.114665890112519 ], [ 1392528.963966277893633, 5858766.460637149401009 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E106", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1165.5, "elevtn_dn": 1165.5, "invlev_up": 1163.0, "invlev_dn": 1163.0, "manhole_up": "manhole_126_generated", "manhole_dn": "manhole_127_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392528.963966277893633, 5858766.460637149401009 ], [ 1392573.284122244687751, 5858789.391092935577035 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E107", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1165.5, "elevtn_dn": 1157.0999755859375, "invlev_up": 1163.0, "invlev_dn": 1154.5999755859375, "manhole_up": "manhole_127_generated", "manhole_dn": "manhole_128_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392573.284122244687751, 5858789.391092935577035 ], [ 1392618.033192394766957, 5858811.600886153057218 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E108", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1157.0999755859375, "elevtn_dn": 1184.800048828125, "invlev_up": 1154.5999755859375, "invlev_dn": 1182.300048828125, "manhole_up": "manhole_128_generated", "manhole_dn": "manhole_129_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392618.033192394766957, 5858811.600886153057218 ], [ 1392666.730896146036685, 5858821.011833874508739 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E109", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1184.800048828125, "elevtn_dn": 1141.2000732421875, "invlev_up": 1182.300048828125, "invlev_dn": 1138.7000732421875, "manhole_up": "manhole_129_generated", "manhole_dn": "manhole_130_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392666.730896146036685, 5858821.011833874508739 ], [ 1392714.397227015113458, 5858809.184477739967406 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E110", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1141.2000732421875, "elevtn_dn": 1141.2000732421875, "invlev_up": 1138.7000732421875, "invlev_dn": 1138.7000732421875, "manhole_up": "manhole_130_generated", "manhole_dn": "manhole_131_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392714.397227015113458, 5858809.184477739967406 ], [ 1392761.799294820055366, 5858794.231293976306915 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E111", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1141.2000732421875, "elevtn_dn": 1137.4000244140625, "invlev_up": 1138.7000732421875, "invlev_dn": 1134.9000244140625, "manhole_up": "manhole_131_generated", "manhole_dn": "manhole_132_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392761.799294820055366, 5858794.231293976306915 ], [ 1392810.095712865469977, 5858797.830352782271802 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E112", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1137.4000244140625, "elevtn_dn": 1137.4000244140625, "invlev_up": 1134.9000244140625, "invlev_dn": 1134.9000244140625, "manhole_up": "manhole_132_generated", "manhole_dn": "manhole_133_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392810.095712865469977, 5858797.830352782271802 ], [ 1392855.660074200481176, 5858817.529770986177027 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E113", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1137.4000244140625, "elevtn_dn": 1169.5, "invlev_up": 1134.9000244140625, "invlev_dn": 1167.0, "manhole_up": "manhole_133_generated", "manhole_dn": "manhole_134_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392855.660074200481176, 5858817.529770986177027 ], [ 1392904.672455, 5858826.347064822912216 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E114", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_134_generated", "manhole_dn": "manhole_135_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392904.672455, 5858826.347064822912216 ], [ 1392949.505032581742853, 5858846.393358059227467 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E115", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_135_generated", "manhole_dn": "manhole_136_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392949.505032581742853, 5858846.393358059227467 ], [ 1392993.956312821945176, 5858868.358838438987732 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E116", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_136_generated", "manhole_dn": "manhole_137_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392993.956312821945176, 5858868.358838438987732 ], [ 1393042.160067020915449, 5858881.479519641026855 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E117", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1162.0, "invlev_up": 1167.0, "invlev_dn": 1159.5, "manhole_up": "manhole_137_generated", "manhole_dn": "manhole_138_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393042.160067020915449, 5858881.479519641026855 ], [ 1393090.363821219652891, 5858894.600200843065977 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E118", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1162.0, "elevtn_dn": 1162.0, "invlev_up": 1159.5, "invlev_dn": 1159.5, "manhole_up": "manhole_138_generated", "manhole_dn": "manhole_139_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393090.363821219652891, 5858894.600200843065977 ], [ 1393138.877780271228403, 5858905.382868006825447 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E119", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1162.0, "elevtn_dn": 1152.0999755859375, "invlev_up": 1159.5, "invlev_dn": 1149.5999755859375, "manhole_up": "manhole_139_generated", "manhole_dn": "manhole_140_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393138.877780271228403, 5858905.382868006825447 ], [ 1393188.835210436256602, 5858905.286093098111451 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E120", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1152.0999755859375, "elevtn_dn": 1152.0999755859375, "invlev_up": 1149.5999755859375, "invlev_dn": 1149.5999755859375, "manhole_up": "manhole_140_generated", "manhole_dn": "manhole_141_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393188.835210436256602, 5858905.286093098111451 ], [ 1393237.248238409170881, 5858916.599204055964947 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E121", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1152.0999755859375, "elevtn_dn": 1147.300048828125, "invlev_up": 1149.5999755859375, "invlev_dn": 1144.800048828125, "manhole_up": "manhole_141_generated", "manhole_dn": "manhole_142_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393237.248238409170881, 5858916.599204055964947 ], [ 1393278.15638761385344, 5858943.766047672368586 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E122", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1147.300048828125, "elevtn_dn": 1182.7000732421875, "invlev_up": 1144.800048828125, "invlev_dn": 1180.2000732421875, "manhole_up": "manhole_142_generated", "manhole_dn": "manhole_143_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393278.15638761385344, 5858943.766047672368586 ], [ 1393316.553906054003164, 5858975.725158606655896 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E123", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1182.7000732421875, "elevtn_dn": 1180.0999755859375, "invlev_up": 1180.2000732421875, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_143_generated", "manhole_dn": "manhole_144_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393316.553906054003164, 5858975.725158606655896 ], [ 1393354.951424494385719, 5859007.684269540011883 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E124", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1180.0999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_144_generated", "manhole_dn": "manhole_145_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393354.951424494385719, 5859007.684269540011883 ], [ 1393393.348942934535444, 5859039.643380474299192 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E125", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1180.0999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_145_generated", "manhole_dn": "manhole_146_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393393.348942934535444, 5859039.643380474299192 ], [ 1393431.746461374685168, 5859071.602491408586502 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E126", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_146_generated", "manhole_dn": "manhole_147_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393431.746461374685168, 5859071.602491408586502 ], [ 1393472.672340910183266, 5859100.089053857140243 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E127", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1200.0999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_147_generated", "manhole_dn": "manhole_148_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393472.672340910183266, 5859100.089053857140243 ], [ 1393507.678647378925234, 5859134.262682756409049 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E128", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1200.0999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_148_generated", "manhole_dn": "manhole_149_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393507.678647378925234, 5859134.262682756409049 ], [ 1393492.637579936999828, 5859179.667013085447252 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E129", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1232.300048828125, "invlev_up": 1200.0999755859375, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_149_generated", "manhole_dn": "manhole_150_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393492.637579936999828, 5859179.667013085447252 ], [ 1393472.727902054553851, 5859225.064155456610024 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E130", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_150_generated", "manhole_dn": "manhole_151_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393472.727902054553851, 5859225.064155456610024 ], [ 1393467.563765458529815, 5859274.587596206925809 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E131", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_151_generated", "manhole_dn": "manhole_152_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393467.563765458529815, 5859274.587596206925809 ], [ 1393473.51405850565061, 5859323.8850102070719 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E132", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_152_generated", "manhole_dn": "manhole_153_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393473.51405850565061, 5859323.8850102070719 ], [ 1393507.773820924572647, 5859356.614802500233054 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E133", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1214.800048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1212.300048828125, "manhole_up": "manhole_153_generated", "manhole_dn": "manhole_154_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393507.773820924572647, 5859356.614802500233054 ], [ 1393555.824224345618859, 5859349.253152369521558 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E134", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1214.800048828125, "elevtn_dn": 1214.800048828125, "invlev_up": 1212.300048828125, "invlev_dn": 1212.300048828125, "manhole_up": "manhole_154_generated", "manhole_dn": "manhole_155_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393555.824224345618859, 5859349.253152369521558 ], [ 1393591.00338595919311, 5859314.794959847815335 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E135", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1214.800048828125, "elevtn_dn": 1191.0999755859375, "invlev_up": 1212.300048828125, "invlev_dn": 1188.5999755859375, "manhole_up": "manhole_155_generated", "manhole_dn": "manhole_156_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393591.00338595919311, 5859314.794959847815335 ], [ 1393633.153639519121498, 5859288.066565420478582 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E136", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1191.0999755859375, "elevtn_dn": 1191.0999755859375, "invlev_up": 1188.5999755859375, "invlev_dn": 1188.5999755859375, "manhole_up": "manhole_156_generated", "manhole_dn": "manhole_157_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393633.153639519121498, 5859288.066565420478582 ], [ 1393673.123904188396409, 5859258.097712650895119 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E137", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1191.0999755859375, "elevtn_dn": 1144.300048828125, "invlev_up": 1188.5999755859375, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_157_generated", "manhole_dn": "manhole_158_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393673.123904188396409, 5859258.097712650895119 ], [ 1393720.523227575467899, 5859244.838272913359106 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E138", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1144.300048828125, "invlev_up": 1141.800048828125, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_158_generated", "manhole_dn": "manhole_159_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393720.523227575467899, 5859244.838272913359106 ], [ 1393765.710014625452459, 5859224.569284616038203 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E139", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1144.300048828125, "invlev_up": 1141.800048828125, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_159_generated", "manhole_dn": "manhole_160_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393765.710014625452459, 5859224.569284616038203 ], [ 1393806.409210936399177, 5859195.609256223775446 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E140", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1112.5, "invlev_up": 1141.800048828125, "invlev_dn": 1110.0, "manhole_up": "manhole_160_generated", "manhole_dn": "manhole_161_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393806.409210936399177, 5859195.609256223775446 ], [ 1393846.866742686368525, 5859166.301538489758968 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1045", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 968.29998779296875, "invlev_up": 965.79998779296875, "invlev_dn": 965.79998779296875, "manhole_up": "manhole_162_generated", "manhole_dn": "manhole_163_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388521.257592596346512, 5855362.027613477781415 ], [ 1388472.030306826578453, 5855370.543775821104646 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1046", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 968.29998779296875, "invlev_up": 965.79998779296875, "invlev_dn": 965.79998779296875, "manhole_up": "manhole_163_generated", "manhole_dn": "manhole_164_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388472.030306826578453, 5855370.543775821104646 ], [ 1388439.000347282737494, 5855407.802592809312046 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1047", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 964.5, "invlev_up": 965.79998779296875, "invlev_dn": 962.0, "manhole_up": "manhole_164_generated", "manhole_dn": "manhole_165_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388439.000347282737494, 5855407.802592809312046 ], [ 1388400.196091859601438, 5855436.014134516008198 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1048", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 964.5, "invlev_up": 962.0, "invlev_dn": 962.0, "manhole_up": "manhole_165_generated", "manhole_dn": "manhole_166_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388400.196091859601438, 5855436.014134516008198 ], [ 1388351.33823574683629, 5855446.634319253265858 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1049", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 981.9000244140625, "invlev_up": 962.0, "invlev_dn": 979.4000244140625, "manhole_up": "manhole_166_generated", "manhole_dn": "manhole_167_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388351.33823574683629, 5855446.634319253265858 ], [ 1388301.961881892289966, 5855453.847477887757123 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1050", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 981.9000244140625, "elevtn_dn": 981.9000244140625, "invlev_up": 979.4000244140625, "invlev_dn": 979.4000244140625, "manhole_up": "manhole_167_generated", "manhole_dn": "manhole_168_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388301.961881892289966, 5855453.847477887757123 ], [ 1388252.297577269142494, 5855451.260453455150127 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1051", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 981.9000244140625, "elevtn_dn": 973.70001220703125, "invlev_up": 979.4000244140625, "invlev_dn": 971.20001220703125, "manhole_up": "manhole_168_generated", "manhole_dn": "manhole_169_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388252.297577269142494, 5855451.260453455150127 ], [ 1388202.479659734526649, 5855455.508814659900963 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1052", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 973.70001220703125, "elevtn_dn": 961.70001220703125, "invlev_up": 971.20001220703125, "invlev_dn": 959.20001220703125, "manhole_up": "manhole_169_generated", "manhole_dn": "manhole_170_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388202.479659734526649, 5855455.508814659900963 ], [ 1388152.683455461403355, 5855460.015516467392445 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1053", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 961.70001220703125, "elevtn_dn": 961.70001220703125, "invlev_up": 959.20001220703125, "invlev_dn": 959.20001220703125, "manhole_up": "manhole_170_generated", "manhole_dn": "manhole_171_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388152.683455461403355, 5855460.015516467392445 ], [ 1388104.622611842118204, 5855473.253733876161277 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1054", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 961.70001220703125, "elevtn_dn": 945.79998779296875, "invlev_up": 959.20001220703125, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_171_generated", "manhole_dn": "manhole_172_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388104.622611842118204, 5855473.253733876161277 ], [ 1388057.00563437351957, 5855488.445189393125474 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1055", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 945.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_172_generated", "manhole_dn": "manhole_173_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388057.00563437351957, 5855488.445189393125474 ], [ 1388011.292356542311609, 5855508.700276436284184 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1056", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 945.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_173_generated", "manhole_dn": "manhole_174_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388011.292356542311609, 5855508.700276436284184 ], [ 1387969.221702651120722, 5855535.246164590120316 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1057", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 930.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 928.29998779296875, "manhole_up": "manhole_174_generated", "manhole_dn": "manhole_175_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.221702651120722, 5855535.246164590120316 ], [ 1387935.863196024205536, 5855572.491061648353934 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1058", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 930.79998779296875, "elevtn_dn": 957.10003662109375, "invlev_up": 928.29998779296875, "invlev_dn": 954.60003662109375, "manhole_up": "manhole_175_generated", "manhole_dn": "manhole_176_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387935.863196024205536, 5855572.491061648353934 ], [ 1387904.610231971368194, 5855611.432584651745856 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1059", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.10003662109375, "elevtn_dn": 947.4000244140625, "invlev_up": 954.60003662109375, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_176_generated", "manhole_dn": "manhole_177_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387904.610231971368194, 5855611.432584651745856 ], [ 1387869.335365027422085, 5855646.852918352000415 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1060", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 947.4000244140625, "invlev_up": 944.9000244140625, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_177_generated", "manhole_dn": "manhole_178_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387869.335365027422085, 5855646.852918352000415 ], [ 1387831.783288773847744, 5855679.735664095729589 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1061", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 947.4000244140625, "invlev_up": 944.9000244140625, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_178_generated", "manhole_dn": "manhole_179_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387831.783288773847744, 5855679.735664095729589 ], [ 1387791.509416193468496, 5855708.923279576934874 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1062", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 933.29998779296875, "invlev_up": 944.9000244140625, "invlev_dn": 930.79998779296875, "manhole_up": "manhole_179_generated", "manhole_dn": "manhole_180_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387791.509416193468496, 5855708.923279576934874 ], [ 1387742.459816947113723, 5855717.213657722808421 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1063", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.29998779296875, "elevtn_dn": 933.29998779296875, "invlev_up": 930.79998779296875, "invlev_dn": 930.79998779296875, "manhole_up": "manhole_180_generated", "manhole_dn": "manhole_181_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387742.459816947113723, 5855717.213657722808421 ], [ 1387692.500367184402421, 5855718.495403698645532 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1064", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.29998779296875, "elevtn_dn": 911.10003662109375, "invlev_up": 930.79998779296875, "invlev_dn": 908.60003662109375, "manhole_up": "manhole_181_generated", "manhole_dn": "manhole_182_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387692.500367184402421, 5855718.495403698645532 ], [ 1387642.500798417022452, 5855718.61967874225229 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1065", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.10003662109375, "elevtn_dn": 887.70001220703125, "invlev_up": 908.60003662109375, "invlev_dn": 885.20001220703125, "manhole_up": "manhole_182_generated", "manhole_dn": "manhole_183_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387642.500798417022452, 5855718.61967874225229 ], [ 1387592.501229649642482, 5855718.743953784927726 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1066", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 887.70001220703125, "elevtn_dn": 887.70001220703125, "invlev_up": 885.20001220703125, "invlev_dn": 885.20001220703125, "manhole_up": "manhole_183_generated", "manhole_dn": "manhole_184_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387592.501229649642482, 5855718.743953784927726 ], [ 1387542.501660882262513, 5855718.868228827603161 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1067", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 887.70001220703125, "elevtn_dn": 902.9000244140625, "invlev_up": 885.20001220703125, "invlev_dn": 900.4000244140625, "manhole_up": "manhole_184_generated", "manhole_dn": "manhole_185_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387542.501660882262513, 5855718.868228827603161 ], [ 1387492.651409652316943, 5855720.815255363471806 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1068", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 902.9000244140625, "elevtn_dn": 902.9000244140625, "invlev_up": 900.4000244140625, "invlev_dn": 900.4000244140625, "manhole_up": "manhole_185_generated", "manhole_dn": "manhole_186_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387492.651409652316943, 5855720.815255363471806 ], [ 1387448.867236748570576, 5855742.752516686916351 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1069", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 902.9000244140625, "elevtn_dn": 886.20001220703125, "invlev_up": 900.4000244140625, "invlev_dn": 883.70001220703125, "manhole_up": "manhole_186_generated", "manhole_dn": "manhole_187_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387448.867236748570576, 5855742.752516686916351 ], [ 1387402.432745414320379, 5855761.091833713464439 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1070", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 886.20001220703125, "elevtn_dn": 886.20001220703125, "invlev_up": 883.70001220703125, "invlev_dn": 883.70001220703125, "manhole_up": "manhole_187_generated", "manhole_dn": "manhole_188_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387402.432745414320379, 5855761.091833713464439 ], [ 1387355.687973388005048, 5855778.837216476909816 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1071", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 886.20001220703125, "elevtn_dn": 879.4000244140625, "invlev_up": 883.70001220703125, "invlev_dn": 876.9000244140625, "manhole_up": "manhole_188_generated", "manhole_dn": "manhole_189_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387355.687973388005048, 5855778.837216476909816 ], [ 1387308.943201361689717, 5855796.582599240355194 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1072", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 879.4000244140625, "elevtn_dn": 879.4000244140625, "invlev_up": 876.9000244140625, "invlev_dn": 876.9000244140625, "manhole_up": "manhole_189_generated", "manhole_dn": "manhole_190_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387308.943201361689717, 5855796.582599240355194 ], [ 1387262.861613623332232, 5855815.656713440082967 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1073", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 879.4000244140625, "elevtn_dn": 873.29998779296875, "invlev_up": 876.9000244140625, "invlev_dn": 870.79998779296875, "manhole_up": "manhole_190_generated", "manhole_dn": "manhole_191_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387262.861613623332232, 5855815.656713440082967 ], [ 1387224.059019178850576, 5855846.996291697025299 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1074", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 873.29998779296875, "elevtn_dn": 938.9000244140625, "invlev_up": 870.79998779296875, "invlev_dn": 936.4000244140625, "manhole_up": "manhole_191_generated", "manhole_dn": "manhole_192_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387224.059019178850576, 5855846.996291697025299 ], [ 1387180.719124856637791, 5855870.194651792757213 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1075", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 938.9000244140625, "elevtn_dn": 932.79998779296875, "invlev_up": 936.4000244140625, "invlev_dn": 930.29998779296875, "manhole_up": "manhole_192_generated", "manhole_dn": "manhole_193_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387180.719124856637791, 5855870.194651792757213 ], [ 1387131.003996425773948, 5855874.064550469629467 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1076", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.79998779296875, "elevtn_dn": 932.79998779296875, "invlev_up": 930.29998779296875, "invlev_dn": 930.29998779296875, "manhole_up": "manhole_193_generated", "manhole_dn": "manhole_194_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387131.003996425773948, 5855874.064550469629467 ], [ 1387081.098878284916282, 5855871.158613862469792 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1077", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.79998779296875, "elevtn_dn": 916.79998779296875, "invlev_up": 930.29998779296875, "invlev_dn": 914.29998779296875, "manhole_up": "manhole_194_generated", "manhole_dn": "manhole_195_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387081.098878284916282, 5855871.158613862469792 ], [ 1387031.198060098802671, 5855868.015261265449226 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1078", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 916.79998779296875, "elevtn_dn": 916.79998779296875, "invlev_up": 914.29998779296875, "invlev_dn": 914.29998779296875, "manhole_up": "manhole_195_generated", "manhole_dn": "manhole_196_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387031.198060098802671, 5855868.015261265449226 ], [ 1386981.297241912456229, 5855864.871908667497337 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1079", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 916.79998779296875, "elevtn_dn": 891.79998779296875, "invlev_up": 914.29998779296875, "invlev_dn": 889.29998779296875, "manhole_up": "manhole_196_generated", "manhole_dn": "manhole_197_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386981.297241912456229, 5855864.871908667497337 ], [ 1386931.47147326474078, 5855860.718019699677825 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1080", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.79998779296875, "elevtn_dn": 891.79998779296875, "invlev_up": 889.29998779296875, "invlev_dn": 889.29998779296875, "manhole_up": "manhole_197_generated", "manhole_dn": "manhole_198_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386931.47147326474078, 5855860.718019699677825 ], [ 1386881.600663758814335, 5855857.577047945931554 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1081", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.79998779296875, "elevtn_dn": 857.10003662109375, "invlev_up": 889.29998779296875, "invlev_dn": 854.60003662109375, "manhole_up": "manhole_198_generated", "manhole_dn": "manhole_199_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386881.600663758814335, 5855857.577047945931554 ], [ 1386832.545593914575875, 5855864.100992278195918 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1082", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 857.10003662109375, "elevtn_dn": 857.10003662109375, "invlev_up": 854.60003662109375, "invlev_dn": 854.60003662109375, "manhole_up": "manhole_199_generated", "manhole_dn": "manhole_200_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386832.545593914575875, 5855864.100992278195918 ], [ 1386787.06764860637486, 5855884.403254445642233 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1083", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 857.10003662109375, "elevtn_dn": 821.29998779296875, "invlev_up": 854.60003662109375, "invlev_dn": 818.79998779296875, "manhole_up": "manhole_200_generated", "manhole_dn": "manhole_201_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386787.06764860637486, 5855884.403254445642233 ], [ 1386748.278358669718727, 5855915.544586268253624 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1084", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 821.29998779296875, "elevtn_dn": 821.29998779296875, "invlev_up": 818.79998779296875, "invlev_dn": 818.79998779296875, "manhole_up": "manhole_201_generated", "manhole_dn": "manhole_202_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386748.278358669718727, 5855915.544586268253624 ], [ 1386721.155419877264649, 5855957.124278785660863 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1085", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 821.29998779296875, "elevtn_dn": 866.0, "invlev_up": 818.79998779296875, "invlev_dn": 863.5, "manhole_up": "manhole_202_generated", "manhole_dn": "manhole_203_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386721.155419877264649, 5855957.124278785660863 ], [ 1386707.750365849817172, 5856004.850832763127983 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1086", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 866.0, "invlev_up": 863.5, "invlev_dn": 863.5, "manhole_up": "manhole_203_generated", "manhole_dn": "manhole_204_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386707.750365849817172, 5856004.850832763127983 ], [ 1386699.832475832896307, 5856054.133603978902102 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1087", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 866.0, "invlev_up": 863.5, "invlev_dn": 863.5, "manhole_up": "manhole_204_generated", "manhole_dn": "manhole_205_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386699.832475832896307, 5856054.133603978902102 ], [ 1386697.095561265014112, 5856103.986880083568394 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1088", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 884.79998779296875, "invlev_up": 863.5, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_205_generated", "manhole_dn": "manhole_206_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386697.095561265014112, 5856103.986880083568394 ], [ 1386699.401158998254687, 5856153.933416903018951 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1089", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 884.79998779296875, "invlev_up": 882.29998779296875, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_206_generated", "manhole_dn": "manhole_207_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386699.401158998254687, 5856153.933416903018951 ], [ 1386715.699191288091242, 5856201.197657831013203 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1090", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 884.79998779296875, "invlev_up": 882.29998779296875, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_207_generated", "manhole_dn": "manhole_208_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386715.699191288091242, 5856201.197657831013203 ], [ 1386741.121203816728666, 5856244.100116757676005 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1091", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 915.9000244140625, "invlev_up": 882.29998779296875, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_208_generated", "manhole_dn": "manhole_209_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386741.121203816728666, 5856244.100116757676005 ], [ 1386774.051378605188802, 5856281.577651324681938 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1092", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_209_generated", "manhole_dn": "manhole_210_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386774.051378605188802, 5856281.577651324681938 ], [ 1386811.583791718119755, 5856314.587093180976808 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1093", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_210_generated", "manhole_dn": "manhole_211_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386811.583791718119755, 5856314.587093180976808 ], [ 1386839.378956499742344, 5856356.087350118905306 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1094", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_211_generated", "manhole_dn": "manhole_212_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386839.378956499742344, 5856356.087350118905306 ], [ 1386855.653891535941511, 5856403.364181768149137 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1095", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_212_generated", "manhole_dn": "manhole_213_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386855.653891535941511, 5856403.364181768149137 ], [ 1386875.714553950354457, 5856449.116945925168693 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1096", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_213_generated", "manhole_dn": "manhole_214_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386875.714553950354457, 5856449.116945925168693 ], [ 1386912.179653002182022, 5856482.939191372133791 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1097", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_214_generated", "manhole_dn": "manhole_215_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386912.179653002182022, 5856482.939191372133791 ], [ 1386944.191176384687424, 5856520.270725904032588 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1098", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 911.79998779296875, "invlev_up": 907.4000244140625, "invlev_dn": 909.29998779296875, "manhole_up": "manhole_215_generated", "manhole_dn": "manhole_216_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386944.191176384687424, 5856520.270725904032588 ], [ 1386964.188513180473819, 5856566.025075756013393 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1099", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.79998779296875, "elevtn_dn": 911.79998779296875, "invlev_up": 909.29998779296875, "invlev_dn": 909.29998779296875, "manhole_up": "manhole_216_generated", "manhole_dn": "manhole_217_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386964.188513180473819, 5856566.025075756013393 ], [ 1386998.825215350603685, 5856599.261941562406719 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1100", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.79998779296875, "elevtn_dn": 932.0, "invlev_up": 909.29998779296875, "invlev_dn": 929.5, "manhole_up": "manhole_217_generated", "manhole_dn": "manhole_218_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386998.825215350603685, 5856599.261941562406719 ], [ 1387044.828526843106374, 5856618.849377661012113 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1101", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 932.0, "invlev_up": 929.5, "invlev_dn": 929.5, "manhole_up": "manhole_218_generated", "manhole_dn": "manhole_219_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387044.828526843106374, 5856618.849377661012113 ], [ 1387090.831838335609064, 5856638.43681376054883 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1102", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 949.9000244140625, "invlev_up": 929.5, "invlev_dn": 947.4000244140625, "manhole_up": "manhole_219_generated", "manhole_dn": "manhole_220_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387090.831838335609064, 5856638.43681376054883 ], [ 1387136.835149827878922, 5856658.024249859154224 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1103", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 949.9000244140625, "elevtn_dn": 924.4000244140625, "invlev_up": 947.4000244140625, "invlev_dn": 921.9000244140625, "manhole_up": "manhole_220_generated", "manhole_dn": "manhole_221_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387136.835149827878922, 5856658.024249859154224 ], [ 1387178.671980312326923, 5856685.128790453076363 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1104", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 924.4000244140625, "elevtn_dn": 924.4000244140625, "invlev_up": 921.9000244140625, "invlev_dn": 921.9000244140625, "manhole_up": "manhole_221_generated", "manhole_dn": "manhole_222_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387178.671980312326923, 5856685.128790453076363 ], [ 1387217.700535611249506, 5856716.320352808572352 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1105", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 924.4000244140625, "elevtn_dn": 940.0, "invlev_up": 921.9000244140625, "invlev_dn": 937.5, "manhole_up": "manhole_222_generated", "manhole_dn": "manhole_223_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387217.700535611249506, 5856716.320352808572352 ], [ 1387252.016686553368345, 5856752.649443434551358 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1106", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.0, "elevtn_dn": 940.0, "invlev_up": 937.5, "invlev_dn": 937.5, "manhole_up": "manhole_223_generated", "manhole_dn": "manhole_224_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387252.016686553368345, 5856752.649443434551358 ], [ 1387284.798919493798167, 5856790.190159549936652 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1107", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.0, "elevtn_dn": 894.29998779296875, "invlev_up": 937.5, "invlev_dn": 891.79998779296875, "manhole_up": "manhole_224_generated", "manhole_dn": "manhole_225_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387284.798919493798167, 5856790.190159549936652 ], [ 1387273.050185391213745, 5856831.931571422144771 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1108", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 894.29998779296875, "elevtn_dn": 891.5, "invlev_up": 891.79998779296875, "invlev_dn": 889.0, "manhole_up": "manhole_225_generated", "manhole_dn": "manhole_226_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387273.050185391213745, 5856831.931571422144771 ], [ 1387226.106990416301414, 5856849.145192969590425 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1109", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.5, "elevtn_dn": 891.5, "invlev_up": 889.0, "invlev_dn": 889.0, "manhole_up": "manhole_226_generated", "manhole_dn": "manhole_227_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387226.106990416301414, 5856849.145192969590425 ], [ 1387179.163795441389084, 5856866.358814516104758 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1110", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.5, "elevtn_dn": 881.0, "invlev_up": 889.0, "invlev_dn": 878.5, "manhole_up": "manhole_227_generated", "manhole_dn": "manhole_228_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387179.163795441389084, 5856866.358814516104758 ], [ 1387132.220600466709584, 5856883.572436063550413 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1111", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_228_generated", "manhole_dn": "manhole_229_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387132.220600466709584, 5856883.572436063550413 ], [ 1387091.513159692520276, 5856911.129930667579174 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1112", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_229_generated", "manhole_dn": "manhole_230_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387091.513159692520276, 5856911.129930667579174 ], [ 1387071.007118243258446, 5856956.15559543017298 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1113", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_230_generated", "manhole_dn": "manhole_231_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387071.007118243258446, 5856956.15559543017298 ], [ 1387043.749112035380676, 5856996.689189162105322 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1114", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 856.5, "invlev_up": 878.5, "invlev_dn": 854.0, "manhole_up": "manhole_231_generated", "manhole_dn": "manhole_232_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387043.749112035380676, 5856996.689189162105322 ], [ 1387004.639443967491388, 5857027.840532388538122 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1115", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_232_generated", "manhole_dn": "manhole_233_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387004.639443967491388, 5857027.840532388538122 ], [ 1386965.529775899834931, 5857058.991875615902245 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1116", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_233_generated", "manhole_dn": "manhole_234_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386965.529775899834931, 5857058.991875615902245 ], [ 1386926.702535050921142, 5857090.440239730291069 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1117", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_234_generated", "manhole_dn": "manhole_235_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386926.702535050921142, 5857090.440239730291069 ], [ 1386899.700979894958436, 5857131.871505072340369 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1118", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_235_generated", "manhole_dn": "manhole_236_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386899.700979894958436, 5857131.871505072340369 ], [ 1386903.6263940166682, 5857181.005935152061284 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1119", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 867.29998779296875, "invlev_up": 854.0, "invlev_dn": 864.79998779296875, "manhole_up": "manhole_236_generated", "manhole_dn": "manhole_237_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386903.6263940166682, 5857181.005935152061284 ], [ 1386920.841401966754347, 5857227.85734468139708 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1120", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 867.29998779296875, "elevtn_dn": 867.29998779296875, "invlev_up": 864.79998779296875, "invlev_dn": 864.79998779296875, "manhole_up": "manhole_237_generated", "manhole_dn": "manhole_238_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386920.841401966754347, 5857227.85734468139708 ], [ 1386940.647245415020734, 5857273.767048302106559 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1121", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 867.29998779296875, "elevtn_dn": 879.0, "invlev_up": 864.79998779296875, "invlev_dn": 876.5, "manhole_up": "manhole_238_generated", "manhole_dn": "manhole_239_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386940.647245415020734, 5857273.767048302106559 ], [ 1386960.453088863519952, 5857319.676751921884716 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1122", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 879.0, "elevtn_dn": 884.5, "invlev_up": 876.5, "invlev_dn": 882.0, "manhole_up": "manhole_239_generated", "manhole_dn": "manhole_240_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386960.453088863519952, 5857319.676751921884716 ], [ 1386980.258932311786339, 5857365.586455542594194 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1123", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 884.5, "invlev_up": 882.0, "invlev_dn": 882.0, "manhole_up": "manhole_240_generated", "manhole_dn": "manhole_241_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386980.258932311786339, 5857365.586455542594194 ], [ 1387000.064775760285556, 5857411.496159162372351 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1124", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 884.5, "invlev_up": 882.0, "invlev_dn": 882.0, "manhole_up": "manhole_241_generated", "manhole_dn": "manhole_242_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387000.064775760285556, 5857411.496159162372351 ], [ 1387007.528902114601806, 5857459.537025099620223 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1125", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 893.20001220703125, "invlev_up": 882.0, "invlev_dn": 890.70001220703125, "manhole_up": "manhole_242_generated", "manhole_dn": "manhole_243_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387007.528902114601806, 5857459.537025099620223 ], [ 1386963.21676475298591, 5857476.629049208015203 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1126", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 893.20001220703125, "elevtn_dn": 893.70001220703125, "invlev_up": 890.70001220703125, "invlev_dn": 891.20001220703125, "manhole_up": "manhole_243_generated", "manhole_dn": "manhole_244_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386963.21676475298591, 5857476.629049208015203 ], [ 1386913.783934087026864, 5857484.135433598421514 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1127", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 893.70001220703125, "elevtn_dn": 893.70001220703125, "invlev_up": 891.20001220703125, "invlev_dn": 891.20001220703125, "manhole_up": "manhole_244_generated", "manhole_dn": "manhole_245_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386913.783934087026864, 5857484.135433598421514 ], [ 1386870.539328352315351, 5857507.055611960589886 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1128", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 893.70001220703125, "elevtn_dn": 889.70001220703125, "invlev_up": 891.20001220703125, "invlev_dn": 887.20001220703125, "manhole_up": "manhole_245_generated", "manhole_dn": "manhole_246_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386870.539328352315351, 5857507.055611960589886 ], [ 1386832.820274166297168, 5857539.877026806585491 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1129", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.70001220703125, "elevtn_dn": 889.70001220703125, "invlev_up": 887.20001220703125, "invlev_dn": 887.20001220703125, "manhole_up": "manhole_246_generated", "manhole_dn": "manhole_247_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386832.820274166297168, 5857539.877026806585491 ], [ 1386795.101531907683238, 5857572.698800123296678 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1130", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.70001220703125, "elevtn_dn": 872.4000244140625, "invlev_up": 887.20001220703125, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_247_generated", "manhole_dn": "manhole_248_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386795.101531907683238, 5857572.698800123296678 ], [ 1386758.257366374600679, 5857606.496797049418092 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1131", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 872.4000244140625, "invlev_up": 869.9000244140625, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_248_generated", "manhole_dn": "manhole_249_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386758.257366374600679, 5857606.496797049418092 ], [ 1386721.502390186069533, 5857640.394349270500243 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1132", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 872.4000244140625, "invlev_up": 869.9000244140625, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_249_generated", "manhole_dn": "manhole_250_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386721.502390186069533, 5857640.394349270500243 ], [ 1386691.639095245627686, 5857680.292891399934888 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1133", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 860.70001220703125, "invlev_up": 869.9000244140625, "invlev_dn": 858.20001220703125, "manhole_up": "manhole_250_generated", "manhole_dn": "manhole_251_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386691.639095245627686, 5857680.292891399934888 ], [ 1386663.127201205352321, 5857721.366519738920033 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1134", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 860.70001220703125, "elevtn_dn": 864.10003662109375, "invlev_up": 858.20001220703125, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_251_generated", "manhole_dn": "manhole_252_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386663.127201205352321, 5857721.366519738920033 ], [ 1386634.70784462057054, 5857762.504245642572641 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1135", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 864.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_252_generated", "manhole_dn": "manhole_253_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386634.70784462057054, 5857762.504245642572641 ], [ 1386606.28848803602159, 5857803.64197154622525 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1136", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 864.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_253_generated", "manhole_dn": "manhole_254_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386606.28848803602159, 5857803.64197154622525 ], [ 1386577.851668093586341, 5857844.766917760483921 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1137", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 836.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 833.60003662109375, "manhole_up": "manhole_254_generated", "manhole_dn": "manhole_255_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386577.851668093586341, 5857844.766917760483921 ], [ 1386559.479123871540651, 5857890.340473555959761 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1138", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 836.10003662109375, "elevtn_dn": 836.10003662109375, "invlev_up": 833.60003662109375, "invlev_dn": 833.60003662109375, "manhole_up": "manhole_255_generated", "manhole_dn": "manhole_256_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386559.479123871540651, 5857890.340473555959761 ], [ 1386576.858566463226452, 5857935.633445805869997 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1139", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 836.10003662109375, "elevtn_dn": 854.9000244140625, "invlev_up": 833.60003662109375, "invlev_dn": 852.4000244140625, "manhole_up": "manhole_256_generated", "manhole_dn": "manhole_257_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386576.858566463226452, 5857935.633445805869997 ], [ 1386619.073707325849682, 5857961.189545376226306 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1140", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.9000244140625, "elevtn_dn": 854.9000244140625, "invlev_up": 852.4000244140625, "invlev_dn": 852.4000244140625, "manhole_up": "manhole_257_generated", "manhole_dn": "manhole_258_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386619.073707325849682, 5857961.189545376226306 ], [ 1386664.860782509436831, 5857981.27706332411617 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1141", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.9000244140625, "elevtn_dn": 871.60003662109375, "invlev_up": 852.4000244140625, "invlev_dn": 869.10003662109375, "manhole_up": "manhole_258_generated", "manhole_dn": "manhole_259_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386664.860782509436831, 5857981.27706332411617 ], [ 1386710.721602912992239, 5858001.195835201069713 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1142", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 871.60003662109375, "elevtn_dn": 865.10003662109375, "invlev_up": 869.10003662109375, "invlev_dn": 862.60003662109375, "manhole_up": "manhole_259_generated", "manhole_dn": "manhole_260_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386710.721602912992239, 5858001.195835201069713 ], [ 1386756.582423316547647, 5858021.114607078954577 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1143", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 865.10003662109375, "elevtn_dn": 864.70001220703125, "invlev_up": 862.60003662109375, "invlev_dn": 862.20001220703125, "manhole_up": "manhole_260_generated", "manhole_dn": "manhole_261_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386756.582423316547647, 5858021.114607078954577 ], [ 1386802.443243720103055, 5858041.033378956839442 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1144", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.70001220703125, "elevtn_dn": 864.70001220703125, "invlev_up": 862.20001220703125, "invlev_dn": 862.20001220703125, "manhole_up": "manhole_261_generated", "manhole_dn": "manhole_262_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386802.443243720103055, 5858041.033378956839442 ], [ 1386848.304064123658463, 5858060.952150834724307 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1145", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.70001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 862.20001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_262_generated", "manhole_dn": "manhole_263_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386848.304064123658463, 5858060.952150834724307 ], [ 1386892.843548113014549, 5858083.471454747952521 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1146", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_263_generated", "manhole_dn": "manhole_264_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386892.843548113014549, 5858083.471454747952521 ], [ 1386931.443847785238177, 5858115.251781782135367 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1147", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 853.60003662109375, "invlev_up": 856.70001220703125, "invlev_dn": 851.10003662109375, "manhole_up": "manhole_264_generated", "manhole_dn": "manhole_265_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386931.443847785238177, 5858115.251781782135367 ], [ 1386970.044147457228974, 5858147.032108817249537 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1148", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 853.60003662109375, "elevtn_dn": 853.60003662109375, "invlev_up": 851.10003662109375, "invlev_dn": 851.10003662109375, "manhole_up": "manhole_265_generated", "manhole_dn": "manhole_266_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386970.044147457228974, 5858147.032108817249537 ], [ 1387008.644447129452601, 5858178.812435851432383 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1149", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 853.60003662109375, "elevtn_dn": 842.4000244140625, "invlev_up": 851.10003662109375, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_266_generated", "manhole_dn": "manhole_267_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387008.644447129452601, 5858178.812435851432383 ], [ 1387047.244746801443398, 5858210.592762886546552 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1150", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 842.4000244140625, "invlev_up": 839.9000244140625, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_267_generated", "manhole_dn": "manhole_268_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387047.244746801443398, 5858210.592762886546552 ], [ 1387085.845046473667026, 5858242.373089920729399 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1151", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 842.4000244140625, "invlev_up": 839.9000244140625, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_268_generated", "manhole_dn": "manhole_269_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387085.845046473667026, 5858242.373089920729399 ], [ 1387124.445346145657822, 5858274.153416955843568 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1152", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 827.60003662109375, "invlev_up": 839.9000244140625, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_269_generated", "manhole_dn": "manhole_270_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387124.445346145657822, 5858274.153416955843568 ], [ 1387163.04564581788145, 5858305.933743990026414 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1153", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_270_generated", "manhole_dn": "manhole_271_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387163.04564581788145, 5858305.933743990026414 ], [ 1387201.829349192325026, 5858337.489215047098696 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1154", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 837.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 835.10003662109375, "manhole_up": "manhole_271_generated", "manhole_dn": "manhole_272_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387201.829349192325026, 5858337.489215047098696 ], [ 1387246.200623227981851, 5858359.687651782296598 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1155", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 837.60003662109375, "elevtn_dn": 837.60003662109375, "invlev_up": 835.10003662109375, "invlev_dn": 835.10003662109375, "manhole_up": "manhole_272_generated", "manhole_dn": "manhole_273_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387246.200623227981851, 5858359.687651782296598 ], [ 1387293.201938283629715, 5858376.741938757710159 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1156", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 837.60003662109375, "elevtn_dn": 843.79998779296875, "invlev_up": 835.10003662109375, "invlev_dn": 841.29998779296875, "manhole_up": "manhole_273_generated", "manhole_dn": "manhole_274_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387293.201938283629715, 5858376.741938757710159 ], [ 1387334.200528149493039, 5858401.732468435540795 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1157", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 843.79998779296875, "elevtn_dn": 822.60003662109375, "invlev_up": 841.29998779296875, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_274_generated", "manhole_dn": "manhole_275_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387334.200528149493039, 5858401.732468435540795 ], [ 1387307.843875054037198, 5858437.110805934295058 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1158", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 822.60003662109375, "invlev_up": 820.10003662109375, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_275_generated", "manhole_dn": "manhole_276_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387307.843875054037198, 5858437.110805934295058 ], [ 1387260.279569417703897, 5858425.045736069791019 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1159", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 820.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_276_generated", "manhole_dn": "manhole_277_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387260.279569417703897, 5858425.045736069791019 ], [ 1387211.448235018178821, 5858414.300554806366563 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1160", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_277_generated", "manhole_dn": "manhole_278_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387211.448235018178821, 5858414.300554806366563 ], [ 1387162.612191663123667, 5858403.576134512200952 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1161", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 822.29998779296875, "invlev_up": 825.10003662109375, "invlev_dn": 819.79998779296875, "manhole_up": "manhole_278_generated", "manhole_dn": "manhole_279_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387162.612191663123667, 5858403.576134512200952 ], [ 1387113.700150535441935, 5858393.210482948459685 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1162", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.29998779296875, "elevtn_dn": 822.29998779296875, "invlev_up": 819.79998779296875, "invlev_dn": 819.79998779296875, "manhole_up": "manhole_279_generated", "manhole_dn": "manhole_280_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387113.700150535441935, 5858393.210482948459685 ], [ 1387064.993171223672107, 5858381.975642333738506 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1163", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.29998779296875, "elevtn_dn": 827.79998779296875, "invlev_up": 819.79998779296875, "invlev_dn": 825.29998779296875, "manhole_up": "manhole_280_generated", "manhole_dn": "manhole_281_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387064.993171223672107, 5858381.975642333738506 ], [ 1387015.796386598376557, 5858376.342007979750633 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1164", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.79998779296875, "elevtn_dn": 827.79998779296875, "invlev_up": 825.29998779296875, "invlev_dn": 825.29998779296875, "manhole_up": "manhole_281_generated", "manhole_dn": "manhole_282_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387015.796386598376557, 5858376.342007979750633 ], [ 1386966.208506174152717, 5858382.746259398758411 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1165", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.79998779296875, "elevtn_dn": 833.9000244140625, "invlev_up": 825.29998779296875, "invlev_dn": 831.4000244140625, "manhole_up": "manhole_282_generated", "manhole_dn": "manhole_283_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386966.208506174152717, 5858382.746259398758411 ], [ 1386916.676812386140227, 5858389.559525708667934 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1166", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 833.9000244140625, "elevtn_dn": 833.9000244140625, "invlev_up": 831.4000244140625, "invlev_dn": 831.4000244140625, "manhole_up": "manhole_283_generated", "manhole_dn": "manhole_284_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386916.676812386140227, 5858389.559525708667934 ], [ 1386867.198860567295924, 5858396.764010772109032 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1167", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 833.9000244140625, "elevtn_dn": 833.20001220703125, "invlev_up": 831.4000244140625, "invlev_dn": 830.70001220703125, "manhole_up": "manhole_284_generated", "manhole_dn": "manhole_285_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386867.198860567295924, 5858396.764010772109032 ], [ 1386820.816385147860274, 5858411.854353901930153 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1168", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 833.20001220703125, "elevtn_dn": 809.60003662109375, "invlev_up": 830.70001220703125, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_285_generated", "manhole_dn": "manhole_286_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386820.816385147860274, 5858411.854353901930153 ], [ 1386841.361234750133008, 5858445.514383808709681 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1169", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 809.79998779296875, "invlev_up": 807.10003662109375, "invlev_dn": 807.29998779296875, "manhole_up": "manhole_286_generated", "manhole_dn": "manhole_287_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386841.361234750133008, 5858445.514383808709681 ], [ 1386890.796275103231892, 5858452.915634987875819 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1170", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.79998779296875, "elevtn_dn": 809.79998779296875, "invlev_up": 807.29998779296875, "invlev_dn": 807.29998779296875, "manhole_up": "manhole_287_generated", "manhole_dn": "manhole_288_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386890.796275103231892, 5858452.915634987875819 ], [ 1386940.277140651131049, 5858460.100081093609333 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1171", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.79998779296875, "elevtn_dn": 805.4000244140625, "invlev_up": 807.29998779296875, "invlev_dn": 802.9000244140625, "manhole_up": "manhole_288_generated", "manhole_dn": "manhole_289_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386940.277140651131049, 5858460.100081093609333 ], [ 1386989.847997799050063, 5858466.483407464809716 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1172", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.4000244140625, "elevtn_dn": 805.4000244140625, "invlev_up": 802.9000244140625, "invlev_dn": 802.9000244140625, "manhole_up": "manhole_289_generated", "manhole_dn": "manhole_290_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386989.847997799050063, 5858466.483407464809716 ], [ 1387039.689648573985323, 5858470.45608530472964 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1173", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.4000244140625, "elevtn_dn": 804.60003662109375, "invlev_up": 802.9000244140625, "invlev_dn": 802.10003662109375, "manhole_up": "manhole_290_generated", "manhole_dn": "manhole_291_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387039.689648573985323, 5858470.45608530472964 ], [ 1387088.843806148739532, 5858479.424946941435337 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1174", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.60003662109375, "elevtn_dn": 809.9000244140625, "invlev_up": 802.10003662109375, "invlev_dn": 807.4000244140625, "manhole_up": "manhole_291_generated", "manhole_dn": "manhole_292_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387088.843806148739532, 5858479.424946941435337 ], [ 1387137.90604472765699, 5858489.061806742101908 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1175", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.9000244140625, "elevtn_dn": 809.9000244140625, "invlev_up": 807.4000244140625, "invlev_dn": 807.4000244140625, "manhole_up": "manhole_292_generated", "manhole_dn": "manhole_293_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387137.90604472765699, 5858489.061806742101908 ], [ 1387186.336529975291342, 5858500.87968063633889 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1176", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.9000244140625, "elevtn_dn": 822.60003662109375, "invlev_up": 807.4000244140625, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_293_generated", "manhole_dn": "manhole_294_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387186.336529975291342, 5858500.87968063633889 ], [ 1387231.661050535272807, 5858521.423059928230941 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1177", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 787.70001220703125, "invlev_up": 820.10003662109375, "invlev_dn": 785.20001220703125, "manhole_up": "manhole_294_generated", "manhole_dn": "manhole_295_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387231.661050535272807, 5858521.423059928230941 ], [ 1387268.120024613803253, 5858555.03504909388721 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1178", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.70001220703125, "elevtn_dn": 787.70001220703125, "invlev_up": 785.20001220703125, "invlev_dn": 785.20001220703125, "manhole_up": "manhole_295_generated", "manhole_dn": "manhole_296_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387268.120024613803253, 5858555.03504909388721 ], [ 1387300.917169471969828, 5858592.775208213366568 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1179", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.70001220703125, "elevtn_dn": 797.10003662109375, "invlev_up": 785.20001220703125, "invlev_dn": 794.60003662109375, "manhole_up": "manhole_296_generated", "manhole_dn": "manhole_297_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387300.917169471969828, 5858592.775208213366568 ], [ 1387340.521646688459441, 5858622.315198052674532 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1180", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 797.10003662109375, "elevtn_dn": 797.10003662109375, "invlev_up": 794.60003662109375, "invlev_dn": 794.60003662109375, "manhole_up": "manhole_297_generated", "manhole_dn": "manhole_298_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387340.521646688459441, 5858622.315198052674532 ], [ 1387387.476920192595571, 5858639.495844470337033 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1181", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 797.10003662109375, "elevtn_dn": 806.10003662109375, "invlev_up": 794.60003662109375, "invlev_dn": 803.60003662109375, "manhole_up": "manhole_298_generated", "manhole_dn": "manhole_299_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387387.476920192595571, 5858639.495844470337033 ], [ 1387436.116963447071612, 5858650.82861250359565 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1182", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.10003662109375, "elevtn_dn": 806.10003662109375, "invlev_up": 803.60003662109375, "invlev_dn": 803.60003662109375, "manhole_up": "manhole_299_generated", "manhole_dn": "manhole_300_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387436.116963447071612, 5858650.82861250359565 ], [ 1387485.194103535497561, 5858660.261457678861916 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1183", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.10003662109375, "elevtn_dn": 807.70001220703125, "invlev_up": 803.60003662109375, "invlev_dn": 805.20001220703125, "manhole_up": "manhole_300_generated", "manhole_dn": "manhole_301_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387485.194103535497561, 5858660.261457678861916 ], [ 1387533.804190448950976, 5858671.493853995576501 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1184", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.70001220703125, "elevtn_dn": 772.20001220703125, "invlev_up": 805.20001220703125, "invlev_dn": 769.70001220703125, "manhole_up": "manhole_301_generated", "manhole_dn": "manhole_302_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387533.804190448950976, 5858671.493853995576501 ], [ 1387580.2968336828053, 5858689.619015210308135 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1185", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.20001220703125, "elevtn_dn": 778.79998779296875, "invlev_up": 769.70001220703125, "invlev_dn": 776.29998779296875, "manhole_up": "manhole_302_generated", "manhole_dn": "manhole_303_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387580.2968336828053, 5858689.619015210308135 ], [ 1387628.455277157016098, 5858703.062848121859133 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1186", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.79998779296875, "elevtn_dn": 778.79998779296875, "invlev_up": 776.29998779296875, "invlev_dn": 776.29998779296875, "manhole_up": "manhole_303_generated", "manhole_dn": "manhole_304_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387628.455277157016098, 5858703.062848121859133 ], [ 1387677.211432087467983, 5858713.7862489502877 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1187", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.79998779296875, "elevtn_dn": 786.70001220703125, "invlev_up": 776.29998779296875, "invlev_dn": 784.20001220703125, "manhole_up": "manhole_304_generated", "manhole_dn": "manhole_305_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387677.211432087467983, 5858713.7862489502877 ], [ 1387726.995392211945727, 5858712.747126803733408 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1188", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.70001220703125, "elevtn_dn": 786.70001220703125, "invlev_up": 784.20001220703125, "invlev_dn": 784.20001220703125, "manhole_up": "manhole_305_generated", "manhole_dn": "manhole_306_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387726.995392211945727, 5858712.747126803733408 ], [ 1387773.343349169706926, 5858725.014477553777397 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1189", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.70001220703125, "elevtn_dn": 797.70001220703125, "invlev_up": 784.20001220703125, "invlev_dn": 795.20001220703125, "manhole_up": "manhole_306_generated", "manhole_dn": "manhole_307_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387773.343349169706926, 5858725.014477553777397 ], [ 1387806.363672176143155, 5858762.310494473204017 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1190", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 797.70001220703125, "elevtn_dn": 797.70001220703125, "invlev_up": 795.20001220703125, "invlev_dn": 795.20001220703125, "manhole_up": "manhole_307_generated", "manhole_dn": "manhole_308_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387806.363672176143155, 5858762.310494473204017 ], [ 1387799.717027904232964, 5858810.149600365199149 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1191", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 797.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 795.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_308_generated", "manhole_dn": "manhole_309_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387799.717027904232964, 5858810.149600365199149 ], [ 1387771.971139753237367, 5858850.86109375115484 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1192", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_309_generated", "manhole_dn": "manhole_310_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387771.971139753237367, 5858850.86109375115484 ], [ 1387723.07675126590766, 5858854.679317841306329 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1193", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_310_generated", "manhole_dn": "manhole_311_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387723.07675126590766, 5858854.679317841306329 ], [ 1387673.274138238513842, 5858850.996178055182099 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1194", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_311_generated", "manhole_dn": "manhole_312_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387673.274138238513842, 5858850.996178055182099 ], [ 1387624.170362570788711, 5858858.384703231044114 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1195", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_312_generated", "manhole_dn": "manhole_313_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387624.170362570788711, 5858858.384703231044114 ], [ 1387575.715393897145987, 5858857.046076283790171 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1196", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_313_generated", "manhole_dn": "manhole_314_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387575.715393897145987, 5858857.046076283790171 ], [ 1387529.438332577701658, 5858838.116818149574101 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1197", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_314_generated", "manhole_dn": "manhole_315_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387529.438332577701658, 5858838.116818149574101 ], [ 1387481.179235466290265, 5858825.222027675248682 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1198", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_315_generated", "manhole_dn": "manhole_316_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387481.179235466290265, 5858825.222027675248682 ], [ 1387432.215501294471323, 5858815.797906777821481 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1199", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 772.79998779296875, "invlev_up": 774.70001220703125, "invlev_dn": 770.29998779296875, "manhole_up": "manhole_316_generated", "manhole_dn": "manhole_317_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387432.215501294471323, 5858815.797906777821481 ], [ 1387382.431881646160036, 5858811.154251328669488 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1200", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.79998779296875, "elevtn_dn": 747.10003662109375, "invlev_up": 770.29998779296875, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_317_generated", "manhole_dn": "manhole_318_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387382.431881646160036, 5858811.154251328669488 ], [ 1387336.607072548242286, 5858824.075685098767281 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1201", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 747.10003662109375, "invlev_up": 744.60003662109375, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_318_generated", "manhole_dn": "manhole_319_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387336.607072548242286, 5858824.075685098767281 ], [ 1387327.458137275883928, 5858870.88596049696207 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1202", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 747.10003662109375, "invlev_up": 744.60003662109375, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_319_generated", "manhole_dn": "manhole_320_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387327.458137275883928, 5858870.88596049696207 ], [ 1387344.619252334116027, 5858917.848375800997019 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1203", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 773.70001220703125, "invlev_up": 744.60003662109375, "invlev_dn": 771.20001220703125, "manhole_up": "manhole_320_generated", "manhole_dn": "manhole_321_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387344.619252334116027, 5858917.848375800997019 ], [ 1387358.089983508689329, 5858965.710649829357862 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1204", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 773.70001220703125, "elevtn_dn": 773.70001220703125, "invlev_up": 771.20001220703125, "invlev_dn": 771.20001220703125, "manhole_up": "manhole_321_generated", "manhole_dn": "manhole_322_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387358.089983508689329, 5858965.710649829357862 ], [ 1387329.564612702699378, 5859003.583583393134177 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1205", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 773.70001220703125, "elevtn_dn": 774.29998779296875, "invlev_up": 771.20001220703125, "invlev_dn": 771.79998779296875, "manhole_up": "manhole_322_generated", "manhole_dn": "manhole_323_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387329.564612702699378, 5859003.583583393134177 ], [ 1387285.783744251355529, 5858993.703191691078246 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1206", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.29998779296875, "elevtn_dn": 774.29998779296875, "invlev_up": 771.79998779296875, "invlev_dn": 771.79998779296875, "manhole_up": "manhole_323_generated", "manhole_dn": "manhole_324_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387285.783744251355529, 5858993.703191691078246 ], [ 1387248.355973182013258, 5858961.31797497626394 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1207", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.29998779296875, "elevtn_dn": 769.4000244140625, "invlev_up": 771.79998779296875, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_324_generated", "manhole_dn": "manhole_325_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387248.355973182013258, 5858961.31797497626394 ], [ 1387199.500433639157563, 5858963.645901591517031 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1208", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 769.4000244140625, "invlev_up": 766.9000244140625, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_325_generated", "manhole_dn": "manhole_326_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387199.500433639157563, 5858963.645901591517031 ], [ 1387151.482699199579656, 5858977.583961015567183 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1209", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 762.60003662109375, "invlev_up": 766.9000244140625, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_326_generated", "manhole_dn": "manhole_327_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387151.482699199579656, 5858977.583961015567183 ], [ 1387103.632611613254994, 5858992.082134889438748 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1210", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 762.60003662109375, "invlev_up": 760.10003662109375, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_327_generated", "manhole_dn": "manhole_328_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387103.632611613254994, 5858992.082134889438748 ], [ 1387055.853339510038495, 5859006.816905959509313 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1211", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 755.79998779296875, "invlev_up": 760.10003662109375, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_328_generated", "manhole_dn": "manhole_329_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387055.853339510038495, 5859006.816905959509313 ], [ 1387008.074067406589165, 5859021.551677029579878 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1212", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_329_generated", "manhole_dn": "manhole_330_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387008.074067406589165, 5859021.551677029579878 ], [ 1386960.294795303372666, 5859036.286448099650443 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1213", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 749.5, "invlev_up": 753.29998779296875, "invlev_dn": 747.0, "manhole_up": "manhole_330_generated", "manhole_dn": "manhole_331_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386960.294795303372666, 5859036.286448099650443 ], [ 1386912.515523200156167, 5859051.021219169721007 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1214", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 749.5, "elevtn_dn": 749.5, "invlev_up": 747.0, "invlev_dn": 747.0, "manhole_up": "manhole_331_generated", "manhole_dn": "manhole_332_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386912.515523200156167, 5859051.021219169721007 ], [ 1386864.736251096706837, 5859065.755990239791572 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1215", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 749.5, "elevtn_dn": 727.10003662109375, "invlev_up": 747.0, "invlev_dn": 724.60003662109375, "manhole_up": "manhole_332_generated", "manhole_dn": "manhole_333_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386864.736251096706837, 5859065.755990239791572 ], [ 1386816.956978993490338, 5859080.490761309862137 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1216", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.10003662109375, "elevtn_dn": 752.29998779296875, "invlev_up": 724.60003662109375, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_333_generated", "manhole_dn": "manhole_334_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386816.956978993490338, 5859080.490761309862137 ], [ 1386769.832018451532349, 5859096.976014334708452 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1217", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 738.0, "invlev_up": 749.79998779296875, "invlev_dn": 735.5, "manhole_up": "manhole_334_generated", "manhole_dn": "manhole_335_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386769.832018451532349, 5859096.976014334708452 ], [ 1386724.102282747160643, 5859117.193917133845389 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1218", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 738.0, "invlev_up": 735.5, "invlev_dn": 735.5, "manhole_up": "manhole_335_generated", "manhole_dn": "manhole_336_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386724.102282747160643, 5859117.193917133845389 ], [ 1386678.372547042788938, 5859137.411819933913648 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1219", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 732.79998779296875, "invlev_up": 735.5, "invlev_dn": 730.29998779296875, "manhole_up": "manhole_336_generated", "manhole_dn": "manhole_337_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386678.372547042788938, 5859137.411819933913648 ], [ 1386632.642811338417232, 5859157.629722733050585 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1220", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.79998779296875, "elevtn_dn": 732.79998779296875, "invlev_up": 730.29998779296875, "invlev_dn": 730.29998779296875, "manhole_up": "manhole_337_generated", "manhole_dn": "manhole_338_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386632.642811338417232, 5859157.629722733050585 ], [ 1386586.913075634045526, 5859177.847625533118844 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1221", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.79998779296875, "elevtn_dn": 732.60003662109375, "invlev_up": 730.29998779296875, "invlev_dn": 730.10003662109375, "manhole_up": "manhole_338_generated", "manhole_dn": "manhole_339_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386586.913075634045526, 5859177.847625533118844 ], [ 1386541.181931287748739, 5859198.062337793409824 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1222", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.60003662109375, "elevtn_dn": 732.60003662109375, "invlev_up": 730.10003662109375, "invlev_dn": 730.10003662109375, "manhole_up": "manhole_339_generated", "manhole_dn": "manhole_340_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386541.181931287748739, 5859198.062337793409824 ], [ 1386495.431538854492828, 5859218.233453613705933 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1223", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.60003662109375, "elevtn_dn": 742.5, "invlev_up": 730.10003662109375, "invlev_dn": 740.0, "manhole_up": "manhole_340_generated", "manhole_dn": "manhole_341_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386495.431538854492828, 5859218.233453613705933 ], [ 1386449.681146421469748, 5859238.404569433070719 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1224", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 742.5, "invlev_up": 740.0, "invlev_dn": 740.0, "manhole_up": "manhole_341_generated", "manhole_dn": "manhole_342_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386449.681146421469748, 5859238.404569433070719 ], [ 1386404.749107032548636, 5859260.314221715554595 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1225", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 717.60003662109375, "invlev_up": 740.0, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_342_generated", "manhole_dn": "manhole_343_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386404.749107032548636, 5859260.314221715554595 ], [ 1386360.756595908896998, 5859284.020064728334546 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1226", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 717.60003662109375, "invlev_up": 715.10003662109375, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_343_generated", "manhole_dn": "manhole_344_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386360.756595908896998, 5859284.020064728334546 ], [ 1386317.622744857333601, 5859309.307279178872705 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1227", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 711.0, "invlev_up": 715.10003662109375, "invlev_dn": 708.5, "manhole_up": "manhole_344_generated", "manhole_dn": "manhole_345_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386317.622744857333601, 5859309.307279178872705 ], [ 1386274.488893805770203, 5859334.594493629410863 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1228", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 711.0, "elevtn_dn": 717.60003662109375, "invlev_up": 708.5, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_345_generated", "manhole_dn": "manhole_346_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386274.488893805770203, 5859334.594493629410863 ], [ 1386231.354723542230204, 5859359.881163572892547 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1229", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 739.0, "invlev_up": 715.10003662109375, "invlev_dn": 736.5, "manhole_up": "manhole_346_generated", "manhole_dn": "manhole_347_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386231.354723542230204, 5859359.881163572892547 ], [ 1386188.788941488368437, 5859385.978958465158939 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1230", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 739.0, "invlev_up": 736.5, "invlev_dn": 736.5, "manhole_up": "manhole_347_generated", "manhole_dn": "manhole_348_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386188.788941488368437, 5859385.978958465158939 ], [ 1386153.170269979629666, 5859420.751348914578557 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1231", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 739.0, "invlev_up": 736.5, "invlev_dn": 736.5, "manhole_up": "manhole_348_generated", "manhole_dn": "manhole_349_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386153.170269979629666, 5859420.751348914578557 ], [ 1386127.241226618411019, 5859463.08446778729558 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1232", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 770.60003662109375, "invlev_up": 736.5, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_349_generated", "manhole_dn": "manhole_350_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386127.241226618411019, 5859463.08446778729558 ], [ 1386108.996456971857697, 5859509.052053713239729 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1233", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_350_generated", "manhole_dn": "manhole_351_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386108.996456971857697, 5859509.052053713239729 ], [ 1386105.954033384332433, 5859558.959127158857882 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1234", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_351_generated", "manhole_dn": "manhole_352_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386105.954033384332433, 5859558.959127158857882 ], [ 1386101.917093347059563, 5859608.782215913757682 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1235", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 779.79998779296875, "invlev_up": 768.10003662109375, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_352_generated", "manhole_dn": "manhole_353_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386101.917093347059563, 5859608.782215913757682 ], [ 1386088.458339030388743, 5859656.652665913105011 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1236", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 779.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_353_generated", "manhole_dn": "manhole_354_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386088.458339030388743, 5859656.652665913105011 ], [ 1386075.652030121767893, 5859704.419184413738549 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1237", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 779.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_354_generated", "manhole_dn": "manhole_355_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386075.652030121767893, 5859704.419184413738549 ], [ 1386076.574770522769541, 5859754.410392354242504 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1238", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_355_generated", "manhole_dn": "manhole_356_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386076.574770522769541, 5859754.410392354242504 ], [ 1386077.497510923538357, 5859804.401600294746459 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1239", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_356_generated", "manhole_dn": "manhole_357_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386077.497510923538357, 5859804.401600294746459 ], [ 1386078.420251324307173, 5859854.392808235250413 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E195", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 814.29998779296875, "elevtn_dn": 802.9000244140625, "invlev_up": 811.79998779296875, "invlev_dn": 800.4000244140625, "manhole_up": "manhole_358_generated", "manhole_dn": "manhole_359_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384050.267680946970358, 5856698.702001548372209 ], [ 1384085.778961833100766, 5856733.441067186184227 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E196", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.9000244140625, "elevtn_dn": 802.9000244140625, "invlev_up": 800.4000244140625, "invlev_dn": 800.4000244140625, "manhole_up": "manhole_359_generated", "manhole_dn": "manhole_360_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384085.778961833100766, 5856733.441067186184227 ], [ 1384122.993944165529683, 5856766.592179889790714 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E197", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.9000244140625, "elevtn_dn": 816.29998779296875, "invlev_up": 800.4000244140625, "invlev_dn": 813.79998779296875, "manhole_up": "manhole_360_generated", "manhole_dn": "manhole_361_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384122.993944165529683, 5856766.592179889790714 ], [ 1384160.350959801580757, 5856799.578122235834599 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E198", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.29998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 813.79998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_361_generated", "manhole_dn": "manhole_362_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384160.350959801580757, 5856799.578122235834599 ], [ 1384198.384374253917485, 5856831.724873264320195 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E199", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 798.29998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_362_generated", "manhole_dn": "manhole_363_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384198.384374253917485, 5856831.724873264320195 ], [ 1384230.112839305773377, 5856870.159957353956997 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E200", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 793.9000244140625, "invlev_up": 798.29998779296875, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_363_generated", "manhole_dn": "manhole_364_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384230.112839305773377, 5856870.159957353956997 ], [ 1384259.121702386764809, 5856910.628996902145445 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E201", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 807.60003662109375, "invlev_up": 791.4000244140625, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_364_generated", "manhole_dn": "manhole_365_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384259.121702386764809, 5856910.628996902145445 ], [ 1384287.023718592710793, 5856951.925833041779697 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E202", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_365_generated", "manhole_dn": "manhole_366_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384287.023718592710793, 5856951.925833041779697 ], [ 1384314.929269487503916, 5856993.22028074786067 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E203", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_366_generated", "manhole_dn": "manhole_367_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384314.929269487503916, 5856993.22028074786067 ], [ 1384344.819752591196448, 5857033.056208833120763 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E204", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_367_generated", "manhole_dn": "manhole_368_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384344.819752591196448, 5857033.056208833120763 ], [ 1384375.891110281459987, 5857072.024425559677184 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E205", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_368_generated", "manhole_dn": "manhole_369_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384375.891110281459987, 5857072.024425559677184 ], [ 1384412.732155854580924, 5857105.507668288424611 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E206", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_369_generated", "manhole_dn": "manhole_370_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384412.732155854580924, 5857105.507668288424611 ], [ 1384450.07948348694481, 5857138.509612204506993 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E207", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_370_generated", "manhole_dn": "manhole_371_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384450.07948348694481, 5857138.509612204506993 ], [ 1384487.42686335532926, 5857171.511497005820274 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E208", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 805.0, "invlev_up": 793.4000244140625, "invlev_dn": 802.5, "manhole_up": "manhole_371_generated", "manhole_dn": "manhole_372_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384487.42686335532926, 5857171.511497005820274 ], [ 1384525.207759798038751, 5857204.014277670532465 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E209", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 796.29998779296875, "invlev_up": 802.5, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_372_generated", "manhole_dn": "manhole_373_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384525.207759798038751, 5857204.014277670532465 ], [ 1384563.111988977529109, 5857236.375065575353801 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E210", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 796.29998779296875, "invlev_up": 793.79998779296875, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_373_generated", "manhole_dn": "manhole_374_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384563.111988977529109, 5857236.375065575353801 ], [ 1384601.016218156786636, 5857268.735853480175138 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E211", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 786.10003662109375, "invlev_up": 793.79998779296875, "invlev_dn": 783.60003662109375, "manhole_up": "manhole_374_generated", "manhole_dn": "manhole_375_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384601.016218156786636, 5857268.735853480175138 ], [ 1384638.920447336044163, 5857301.096641384996474 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E212", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.10003662109375, "elevtn_dn": 794.29998779296875, "invlev_up": 783.60003662109375, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_375_generated", "manhole_dn": "manhole_376_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384638.920447336044163, 5857301.096641384996474 ], [ 1384669.604954990325496, 5857340.313404724933207 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E213", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 794.29998779296875, "invlev_up": 791.79998779296875, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_376_generated", "manhole_dn": "manhole_377_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384669.604954990325496, 5857340.313404724933207 ], [ 1384699.518247769214213, 5857380.104403200559318 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E214", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 794.29998779296875, "invlev_up": 791.79998779296875, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_377_generated", "manhole_dn": "manhole_378_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384699.518247769214213, 5857380.104403200559318 ], [ 1384719.806332413339987, 5857425.627417215146124 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E215", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 782.0, "invlev_up": 791.79998779296875, "invlev_dn": 779.5, "manhole_up": "manhole_378_generated", "manhole_dn": "manhole_379_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384719.806332413339987, 5857425.627417215146124 ], [ 1384740.094417057465762, 5857471.150431229732931 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E216", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 782.0, "elevtn_dn": 789.70001220703125, "invlev_up": 779.5, "invlev_dn": 787.20001220703125, "manhole_up": "manhole_379_generated", "manhole_dn": "manhole_380_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384740.094417057465762, 5857471.150431229732931 ], [ 1384760.382501701591536, 5857516.673445244319737 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E217", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 789.70001220703125, "elevtn_dn": 789.70001220703125, "invlev_up": 787.20001220703125, "invlev_dn": 787.20001220703125, "manhole_up": "manhole_380_generated", "manhole_dn": "manhole_381_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384760.382501701591536, 5857516.673445244319737 ], [ 1384780.670586345717311, 5857562.196459258906543 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E218", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 789.70001220703125, "elevtn_dn": 796.5, "invlev_up": 787.20001220703125, "invlev_dn": 794.0, "manhole_up": "manhole_381_generated", "manhole_dn": "manhole_382_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384780.670586345717311, 5857562.196459258906543 ], [ 1384802.672203443944454, 5857606.838341221213341 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E219", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.5, "elevtn_dn": 771.9000244140625, "invlev_up": 794.0, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_382_generated", "manhole_dn": "manhole_383_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384802.672203443944454, 5857606.838341221213341 ], [ 1384827.896526007680222, 5857649.823044718243182 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E220", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_383_generated", "manhole_dn": "manhole_384_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384827.896526007680222, 5857649.823044718243182 ], [ 1384854.757882944308221, 5857691.606820800341666 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E221", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_384_generated", "manhole_dn": "manhole_385_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384854.757882944308221, 5857691.606820800341666 ], [ 1384888.185768931638449, 5857728.573395187035203 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E222", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_385_generated", "manhole_dn": "manhole_386_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384888.185768931638449, 5857728.573395187035203 ], [ 1384921.613654918735847, 5857765.539969574660063 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E223", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 755.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_386_generated", "manhole_dn": "manhole_387_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384921.613654918735847, 5857765.539969574660063 ], [ 1384956.145453942706808, 5857801.445756647735834 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E224", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 755.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_387_generated", "manhole_dn": "manhole_388_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384956.145453942706808, 5857801.445756647735834 ], [ 1384991.751306539867073, 5857836.319449373520911 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E225", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 746.0, "invlev_up": 755.4000244140625, "invlev_dn": 743.5, "manhole_up": "manhole_388_generated", "manhole_dn": "manhole_389_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384991.751306539867073, 5857836.319449373520911 ], [ 1385027.357159137027338, 5857871.193142099305987 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E226", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 746.0, "elevtn_dn": 755.79998779296875, "invlev_up": 743.5, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_389_generated", "manhole_dn": "manhole_390_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385027.357159137027338, 5857871.193142099305987 ], [ 1385062.963011734187603, 5857906.066834825091064 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E227", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 728.60003662109375, "invlev_up": 753.29998779296875, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_390_generated", "manhole_dn": "manhole_391_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385062.963011734187603, 5857906.066834825091064 ], [ 1385098.568864331347868, 5857940.940527551807463 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E228", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 728.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_391_generated", "manhole_dn": "manhole_392_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385098.568864331347868, 5857940.940527551807463 ], [ 1385135.753846400883049, 5857974.029479116201401 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E229", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 728.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_392_generated", "manhole_dn": "manhole_393_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385135.753846400883049, 5857974.029479116201401 ], [ 1385175.738456205930561, 5858003.622975903563201 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E230", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 735.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 733.10003662109375, "manhole_up": "manhole_393_generated", "manhole_dn": "manhole_394_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385175.738456205930561, 5858003.622975903563201 ], [ 1385218.653756857383996, 5858028.965196672827005 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E231", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 735.60003662109375, "elevtn_dn": 735.60003662109375, "invlev_up": 733.10003662109375, "invlev_dn": 733.10003662109375, "manhole_up": "manhole_394_generated", "manhole_dn": "manhole_395_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385218.653756857383996, 5858028.965196672827005 ], [ 1385262.454936756985262, 5858052.706982978619635 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E232", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 735.60003662109375, "elevtn_dn": 742.0, "invlev_up": 733.10003662109375, "invlev_dn": 739.5, "manhole_up": "manhole_395_generated", "manhole_dn": "manhole_396_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385262.454936756985262, 5858052.706982978619635 ], [ 1385306.715555034345016, 5858075.618745312094688 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E233", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.0, "elevtn_dn": 742.0, "invlev_up": 739.5, "invlev_dn": 739.5, "manhole_up": "manhole_396_generated", "manhole_dn": "manhole_397_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385306.715555034345016, 5858075.618745312094688 ], [ 1385350.97617331170477, 5858098.530507644638419 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E234", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.0, "elevtn_dn": 736.0, "invlev_up": 739.5, "invlev_dn": 733.5, "manhole_up": "manhole_397_generated", "manhole_dn": "manhole_398_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385350.97617331170477, 5858098.530507644638419 ], [ 1385395.236791589297354, 5858121.442269978113472 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E235", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 736.0, "elevtn_dn": 736.0, "invlev_up": 733.5, "invlev_dn": 733.5, "manhole_up": "manhole_398_generated", "manhole_dn": "manhole_399_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385395.236791589297354, 5858121.442269978113472 ], [ 1385439.497409866657108, 5858144.354032310657203 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E236", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 736.0, "elevtn_dn": 737.9000244140625, "invlev_up": 733.5, "invlev_dn": 735.4000244140625, "manhole_up": "manhole_399_generated", "manhole_dn": "manhole_400_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385439.497409866657108, 5858144.354032310657203 ], [ 1385483.758028144016862, 5858167.265794644132257 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E237", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.9000244140625, "elevtn_dn": 737.9000244140625, "invlev_up": 735.4000244140625, "invlev_dn": 735.4000244140625, "manhole_up": "manhole_400_generated", "manhole_dn": "manhole_401_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385483.758028144016862, 5858167.265794644132257 ], [ 1385528.018646421376616, 5858190.17755697760731 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E238", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.9000244140625, "elevtn_dn": 727.29998779296875, "invlev_up": 735.4000244140625, "invlev_dn": 724.79998779296875, "manhole_up": "manhole_401_generated", "manhole_dn": "manhole_402_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385528.018646421376616, 5858190.17755697760731 ], [ 1385571.606102279853076, 5858214.277655217796564 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E239", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.29998779296875, "elevtn_dn": 727.29998779296875, "invlev_up": 724.79998779296875, "invlev_dn": 724.79998779296875, "manhole_up": "manhole_402_generated", "manhole_dn": "manhole_403_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385571.606102279853076, 5858214.277655217796564 ], [ 1385614.013400863157585, 5858240.461089110001922 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E240", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.29998779296875, "elevtn_dn": 690.60003662109375, "invlev_up": 724.79998779296875, "invlev_dn": 688.10003662109375, "manhole_up": "manhole_403_generated", "manhole_dn": "manhole_404_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385614.013400863157585, 5858240.461089110001922 ], [ 1385656.420699446462095, 5858266.644523002207279 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E241", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 690.60003662109375, "elevtn_dn": 733.60003662109375, "invlev_up": 688.10003662109375, "invlev_dn": 731.10003662109375, "manhole_up": "manhole_404_generated", "manhole_dn": "manhole_405_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385656.420699446462095, 5858266.644523002207279 ], [ 1385698.773111530812457, 5858292.8961898451671 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E242", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 733.60003662109375, "elevtn_dn": 733.60003662109375, "invlev_up": 731.10003662109375, "invlev_dn": 731.10003662109375, "manhole_up": "manhole_405_generated", "manhole_dn": "manhole_406_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385698.773111530812457, 5858292.8961898451671 ], [ 1385733.435650466475636, 5858328.707634637132287 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E243", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 733.60003662109375, "elevtn_dn": 721.60003662109375, "invlev_up": 731.10003662109375, "invlev_dn": 719.10003662109375, "manhole_up": "manhole_406_generated", "manhole_dn": "manhole_407_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385733.435650466475636, 5858328.707634637132287 ], [ 1385768.098189401905984, 5858364.519079428166151 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E244", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 721.60003662109375, "elevtn_dn": 721.60003662109375, "invlev_up": 719.10003662109375, "invlev_dn": 719.10003662109375, "manhole_up": "manhole_407_generated", "manhole_dn": "manhole_408_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385768.098189401905984, 5858364.519079428166151 ], [ 1385795.882535298354924, 5858405.467093757353723 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E245", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 721.60003662109375, "elevtn_dn": 739.0, "invlev_up": 719.10003662109375, "invlev_dn": 736.5, "manhole_up": "manhole_408_generated", "manhole_dn": "manhole_409_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385795.882535298354924, 5858405.467093757353723 ], [ 1385820.377634756267071, 5858448.871486231684685 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E246", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 727.79998779296875, "invlev_up": 736.5, "invlev_dn": 725.29998779296875, "manhole_up": "manhole_409_generated", "manhole_dn": "manhole_410_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385820.377634756267071, 5858448.871486231684685 ], [ 1385841.084314390551299, 5858493.920932004228234 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E247", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.79998779296875, "elevtn_dn": 727.79998779296875, "invlev_up": 725.29998779296875, "invlev_dn": 725.29998779296875, "manhole_up": "manhole_410_generated", "manhole_dn": "manhole_411_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385841.084314390551299, 5858493.920932004228234 ], [ 1385856.076261736918241, 5858541.451897682622075 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E248", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.79998779296875, "elevtn_dn": 734.9000244140625, "invlev_up": 725.29998779296875, "invlev_dn": 732.4000244140625, "manhole_up": "manhole_411_generated", "manhole_dn": "manhole_412_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385856.076261736918241, 5858541.451897682622075 ], [ 1385865.668899663724005, 5858590.250006795860827 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E249", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 734.9000244140625, "elevtn_dn": 734.9000244140625, "invlev_up": 732.4000244140625, "invlev_dn": 732.4000244140625, "manhole_up": "manhole_412_generated", "manhole_dn": "manhole_413_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385865.668899663724005, 5858590.250006795860827 ], [ 1385873.387286560609937, 5858639.487976770848036 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E250", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 734.9000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 732.4000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_413_generated", "manhole_dn": "manhole_414_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385873.387286560609937, 5858639.487976770848036 ], [ 1385875.017949819331989, 5858689.287253175862134 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E251", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 748.9000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_414_generated", "manhole_dn": "manhole_415_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385875.017949819331989, 5858689.287253175862134 ], [ 1385876.432928551919758, 5858739.106416343711317 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E252", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 748.9000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_415_generated", "manhole_dn": "manhole_416_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385876.432928551919758, 5858739.106416343711317 ], [ 1385878.329821793129668, 5858788.908141564577818 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E253", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 748.9000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_416_generated", "manhole_dn": "manhole_417_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385878.329821793129668, 5858788.908141564577818 ], [ 1385880.51921496167779, 5858838.69928275514394 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E254", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_417_generated", "manhole_dn": "manhole_418_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385880.51921496167779, 5858838.69928275514394 ], [ 1385882.620351102668792, 5858888.493530485779047 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E255", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_418_generated", "manhole_dn": "manhole_419_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385882.620351102668792, 5858888.493530485779047 ], [ 1385883.937443709466606, 5858938.315377607010305 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E256", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 766.10003662109375, "invlev_up": 757.20001220703125, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_419_generated", "manhole_dn": "manhole_420_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385883.937443709466606, 5858938.315377607010305 ], [ 1385885.254538560518995, 5858988.137224668636918 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E257", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 766.10003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_420_generated", "manhole_dn": "manhole_421_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385885.254538560518995, 5858988.137224668636918 ], [ 1385890.650534195825458, 5859037.630400610156357 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E258", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 766.10003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_421_generated", "manhole_dn": "manhole_422_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385890.650534195825458, 5859037.630400610156357 ], [ 1385901.777442803606391, 5859086.09239396546036 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E259", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 768.60003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 766.10003662109375, "manhole_up": "manhole_422_generated", "manhole_dn": "manhole_423_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385901.777442803606391, 5859086.09239396546036 ], [ 1385915.397954803425819, 5859134.03436760418117 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E260", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.60003662109375, "elevtn_dn": 762.79998779296875, "invlev_up": 766.10003662109375, "invlev_dn": 760.29998779296875, "manhole_up": "manhole_423_generated", "manhole_dn": "manhole_424_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385915.397954803425819, 5859134.03436760418117 ], [ 1385928.42605347908102, 5859182.139209139160812 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E261", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.79998779296875, "elevtn_dn": 762.5, "invlev_up": 760.29998779296875, "invlev_dn": 760.0, "manhole_up": "manhole_424_generated", "manhole_dn": "manhole_425_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385928.42605347908102, 5859182.139209139160812 ], [ 1385941.228082312969491, 5859230.306202415376902 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E262", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 762.5, "invlev_up": 760.0, "invlev_dn": 760.0, "manhole_up": "manhole_425_generated", "manhole_dn": "manhole_426_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385941.228082312969491, 5859230.306202415376902 ], [ 1385945.092689140234143, 5859279.734331246465445 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E263", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 762.5, "invlev_up": 760.0, "invlev_dn": 760.0, "manhole_up": "manhole_426_generated", "manhole_dn": "manhole_427_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385945.092689140234143, 5859279.734331246465445 ], [ 1385937.902412303024903, 5859328.779896341264248 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E264", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 778.0, "invlev_up": 760.0, "invlev_dn": 775.5, "manhole_up": "manhole_427_generated", "manhole_dn": "manhole_428_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.902412303024903, 5859328.779896341264248 ], [ 1385932.795075723901391, 5859378.173214216716588 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E265", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 778.0, "invlev_up": 775.5, "invlev_dn": 775.5, "manhole_up": "manhole_428_generated", "manhole_dn": "manhole_429_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385932.795075723901391, 5859378.173214216716588 ], [ 1385937.702695531537756, 5859427.770254967734218 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E266", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 778.0, "invlev_up": 775.5, "invlev_dn": 775.5, "manhole_up": "manhole_429_generated", "manhole_dn": "manhole_430_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.702695531537756, 5859427.770254967734218 ], [ 1385939.035937832202762, 5859477.50230407807976 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E267", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 795.9000244140625, "invlev_up": 775.5, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_430_generated", "manhole_dn": "manhole_431_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385939.035937832202762, 5859477.50230407807976 ], [ 1385937.883638251805678, 5859527.328234969638288 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E268", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_431_generated", "manhole_dn": "manhole_432_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.883638251805678, 5859527.328234969638288 ], [ 1385940.515994266141206, 5859576.989168248139322 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E269", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_432_generated", "manhole_dn": "manhole_433_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385940.515994266141206, 5859576.989168248139322 ], [ 1385950.701545101590455, 5859625.530176519416273 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E270", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 815.0, "invlev_up": 793.4000244140625, "invlev_dn": 812.5, "manhole_up": "manhole_433_generated", "manhole_dn": "manhole_434_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385950.701545101590455, 5859625.530176519416273 ], [ 1385970.467743494315073, 5859670.991298755630851 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E271", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 815.0, "elevtn_dn": 815.0, "invlev_up": 812.5, "invlev_dn": 812.5, "manhole_up": "manhole_434_generated", "manhole_dn": "manhole_435_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385970.467743494315073, 5859670.991298755630851 ], [ 1386011.983088220236823, 5859697.862916950136423 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E272", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 815.0, "elevtn_dn": 779.79998779296875, "invlev_up": 812.5, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_435_generated", "manhole_dn": "manhole_436_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386011.983088220236823, 5859697.862916950136423 ], [ 1386052.213596233632416, 5859727.119808158837259 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E273", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_436_generated", "manhole_dn": "manhole_437_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386052.213596233632416, 5859727.119808158837259 ], [ 1386046.501012831227854, 5859771.612671964801848 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E274", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_437_generated", "manhole_dn": "manhole_438_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386046.501012831227854, 5859771.612671964801848 ], [ 1386026.809695787727833, 5859816.873920152895153 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E275", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_438_generated", "manhole_dn": "manhole_439_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386026.809695787727833, 5859816.873920152895153 ], [ 1386030.149607364553958, 5859866.379009906202555 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E276", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_439_generated", "manhole_dn": "manhole_440_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386030.149607364553958, 5859866.379009906202555 ], [ 1386045.250939248362556, 5859913.859036295674741 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 798.29998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_441_generated", "manhole_dn": "manhole_442_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384196.861816460033879, 5856829.88048410974443 ], [ 1384235.22519311751239, 5856854.977665597572923 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 793.9000244140625, "invlev_up": 798.29998779296875, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_442_generated", "manhole_dn": "manhole_443_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384235.22519311751239, 5856854.977665597572923 ], [ 1384263.450329831801355, 5856892.038370934315026 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 793.9000244140625, "invlev_up": 791.4000244140625, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_443_generated", "manhole_dn": "manhole_444_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384263.450329831801355, 5856892.038370934315026 ], [ 1384291.675466545857489, 5856929.099076271057129 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 807.60003662109375, "invlev_up": 791.4000244140625, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_444_generated", "manhole_dn": "manhole_445_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384291.675466545857489, 5856929.099076271057129 ], [ 1384319.900603260146454, 5856966.159781608730555 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_445_generated", "manhole_dn": "manhole_446_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384319.900603260146454, 5856966.159781608730555 ], [ 1384347.205867683747783, 5857003.894510924816132 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 799.0, "invlev_up": 805.10003662109375, "invlev_dn": 796.5, "manhole_up": "manhole_446_generated", "manhole_dn": "manhole_447_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384347.205867683747783, 5857003.894510924816132 ], [ 1384380.322691001230851, 5857036.360282040201128 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 799.0, "elevtn_dn": 807.60003662109375, "invlev_up": 796.5, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_447_generated", "manhole_dn": "manhole_448_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384380.322691001230851, 5857036.360282040201128 ], [ 1384415.156610523350537, 5857067.291694445535541 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_448_generated", "manhole_dn": "manhole_449_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384415.156610523350537, 5857067.291694445535541 ], [ 1384449.343575850594789, 5857098.828100205399096 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_449_generated", "manhole_dn": "manhole_450_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384449.343575850594789, 5857098.828100205399096 ], [ 1384470.004810179118067, 5857139.926174183376133 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_450_generated", "manhole_dn": "manhole_451_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384470.004810179118067, 5857139.926174183376133 ], [ 1384484.18076178082265, 5857184.301805094815791 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_452_generated", "manhole_dn": "manhole_453_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384289.06552429520525, 5856954.947841017507017 ], [ 1384305.049610810354352, 5856994.88734863139689 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_453_generated", "manhole_dn": "manhole_454_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384305.049610810354352, 5856994.88734863139689 ], [ 1384321.033697325503454, 5857034.82685624435544 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 799.0, "invlev_up": 805.10003662109375, "invlev_dn": 796.5, "manhole_up": "manhole_454_generated", "manhole_dn": "manhole_455_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384321.033697325503454, 5857034.82685624435544 ], [ 1384347.445656489115208, 5857068.672038841992617 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 799.0, "elevtn_dn": 807.60003662109375, "invlev_up": 796.5, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_455_generated", "manhole_dn": "manhole_456_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384347.445656489115208, 5857068.672038841992617 ], [ 1384374.130628447979689, 5857102.406951548531651 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_456_generated", "manhole_dn": "manhole_457_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384374.130628447979689, 5857102.406951548531651 ], [ 1384399.587644136510789, 5857137.08541233278811 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_457_generated", "manhole_dn": "manhole_458_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384399.587644136510789, 5857137.08541233278811 ], [ 1384425.04465982504189, 5857171.763873117044568 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_458_generated", "manhole_dn": "manhole_459_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384425.04465982504189, 5857171.763873117044568 ], [ 1384456.866520966170356, 5857200.577977900393307 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_15_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_15", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_15", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_459_generated", "manhole_dn": "manhole_460_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384456.866520966170356, 5857200.577977900393307 ], [ 1384480.774830641923472, 5857195.244455400854349 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_17_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_17", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_17", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 805.0, "invlev_up": 793.4000244140625, "invlev_dn": 802.5, "manhole_up": "manhole_459_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384456.866520966170356, 5857200.577977900393307 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_18_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_18", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_18", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_462_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384493.329776774393395, 5857201.952337642200291 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_19_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_19", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_19", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_462_generated", "manhole_dn": "manhole_463_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384493.329776774393395, 5857201.952337642200291 ], [ 1384511.321100181667134, 5857246.008046119473875 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_19_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_19", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_19", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_463_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384511.321100181667134, 5857246.008046119473875 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 796.29998779296875, "invlev_up": 802.5, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_464_generated", "manhole_dn": "manhole_465_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384512.484966830350459, 5857248.858029337599874 ], [ 1384550.208547196350992, 5857281.609186780638993 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 796.29998779296875, "invlev_up": 793.79998779296875, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_465_generated", "manhole_dn": "manhole_466_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384550.208547196350992, 5857281.609186780638993 ], [ 1384587.932127562351525, 5857314.360344224609435 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 809.10003662109375, "invlev_up": 793.79998779296875, "invlev_dn": 806.60003662109375, "manhole_up": "manhole_466_generated", "manhole_dn": "manhole_467_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384587.932127562351525, 5857314.360344224609435 ], [ 1384608.456866907887161, 5857358.785165345296264 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.10003662109375, "elevtn_dn": 809.10003662109375, "invlev_up": 806.60003662109375, "invlev_dn": 806.60003662109375, "manhole_up": "manhole_467_generated", "manhole_dn": "manhole_468_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384608.456866907887161, 5857358.785165345296264 ], [ 1384624.966163935838267, 5857405.935456342995167 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.10003662109375, "elevtn_dn": 794.29998779296875, "invlev_up": 806.60003662109375, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_468_generated", "manhole_dn": "manhole_469_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384624.966163935838267, 5857405.935456342995167 ], [ 1384639.938245237572119, 5857453.586039477027953 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 812.4000244140625, "invlev_up": 791.79998779296875, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_469_generated", "manhole_dn": "manhole_470_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384639.938245237572119, 5857453.586039477027953 ], [ 1384654.3423755497206, 5857501.421464210376143 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 812.4000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_470_generated", "manhole_dn": "manhole_471_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384654.3423755497206, 5857501.421464210376143 ], [ 1384665.748858094681054, 5857550.055336253717542 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 812.4000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_471_generated", "manhole_dn": "manhole_472_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384665.748858094681054, 5857550.055336253717542 ], [ 1384677.04772660904564, 5857598.717872150242329 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 818.9000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 816.4000244140625, "manhole_up": "manhole_472_generated", "manhole_dn": "manhole_473_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384677.04772660904564, 5857598.717872150242329 ], [ 1384688.346595123410225, 5857647.380408045835793 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.9000244140625, "elevtn_dn": 818.9000244140625, "invlev_up": 816.4000244140625, "invlev_dn": 816.4000244140625, "manhole_up": "manhole_473_generated", "manhole_dn": "manhole_474_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384688.346595123410225, 5857647.380408045835793 ], [ 1384699.64546363777481, 5857696.042943941429257 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.9000244140625, "elevtn_dn": 791.0, "invlev_up": 816.4000244140625, "invlev_dn": 788.5, "manhole_up": "manhole_474_generated", "manhole_dn": "manhole_475_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384699.64546363777481, 5857696.042943941429257 ], [ 1384710.944332152139395, 5857744.705479837954044 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 771.9000244140625, "invlev_up": 788.5, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_475_generated", "manhole_dn": "manhole_476_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384710.944332152139395, 5857744.705479837954044 ], [ 1384726.848783193388954, 5857791.671307560056448 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_476_generated", "manhole_dn": "manhole_477_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384726.848783193388954, 5857791.671307560056448 ], [ 1384753.929338480113074, 5857833.199649352580309 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_477_generated", "manhole_dn": "manhole_478_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384753.929338480113074, 5857833.199649352580309 ], [ 1384783.627482200739905, 5857873.006575288251042 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 791.0, "invlev_up": 769.4000244140625, "invlev_dn": 788.5, "manhole_up": "manhole_478_generated", "manhole_dn": "manhole_479_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384783.627482200739905, 5857873.006575288251042 ], [ 1384795.018452654592693, 5857920.637507135979831 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 791.0, "invlev_up": 788.5, "invlev_dn": 788.5, "manhole_up": "manhole_479_generated", "manhole_dn": "manhole_480_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384795.018452654592693, 5857920.637507135979831 ], [ 1384785.075932276435196, 5857969.445633230730891 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 820.10003662109375, "invlev_up": 788.5, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_480_generated", "manhole_dn": "manhole_481_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384785.075932276435196, 5857969.445633230730891 ], [ 1384771.479073295136914, 5858017.516749874688685 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 820.10003662109375, "invlev_up": 817.60003662109375, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_481_generated", "manhole_dn": "manhole_482_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384771.479073295136914, 5858017.516749874688685 ], [ 1384763.32518996251747, 5858066.675425447523594 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 820.10003662109375, "invlev_up": 817.60003662109375, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_482_generated", "manhole_dn": "manhole_483_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384763.32518996251747, 5858066.675425447523594 ], [ 1384757.405406558187678, 5858116.280495692044497 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 847.0, "invlev_up": 817.60003662109375, "invlev_dn": 844.5, "manhole_up": "manhole_483_generated", "manhole_dn": "manhole_484_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384757.405406558187678, 5858116.280495692044497 ], [ 1384746.211964494548738, 5858164.956996791996062 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 847.0, "invlev_up": 844.5, "invlev_dn": 844.5, "manhole_up": "manhole_484_generated", "manhole_dn": "manhole_485_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384746.211964494548738, 5858164.956996791996062 ], [ 1384738.028054837835953, 5858213.862443570047617 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 847.0, "invlev_up": 844.5, "invlev_dn": 844.5, "manhole_up": "manhole_485_generated", "manhole_dn": "manhole_486_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384738.028054837835953, 5858213.862443570047617 ], [ 1384756.479259133106098, 5858259.218586039729416 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 833.20001220703125, "invlev_up": 844.5, "invlev_dn": 830.70001220703125, "manhole_up": "manhole_486_generated", "manhole_dn": "manhole_487_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384756.479259133106098, 5858259.218586039729416 ], [ 1384792.653981153853238, 5858293.25339647103101 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 833.20001220703125, "elevtn_dn": 762.29998779296875, "invlev_up": 830.70001220703125, "invlev_dn": 759.79998779296875, "manhole_up": "manhole_487_generated", "manhole_dn": "manhole_488_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384792.653981153853238, 5858293.25339647103101 ], [ 1384839.146884107263759, 5858310.949097327888012 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.29998779296875, "elevtn_dn": 762.29998779296875, "invlev_up": 759.79998779296875, "invlev_dn": 759.79998779296875, "manhole_up": "manhole_488_generated", "manhole_dn": "manhole_489_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384839.146884107263759, 5858310.949097327888012 ], [ 1384888.517509665805846, 5858307.535864246077836 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.29998779296875, "elevtn_dn": 751.0, "invlev_up": 759.79998779296875, "invlev_dn": 748.5, "manhole_up": "manhole_489_generated", "manhole_dn": "manhole_490_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384888.517509665805846, 5858307.535864246077836 ], [ 1384936.622762819286436, 5858294.068231076002121 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.0, "elevtn_dn": 751.0, "invlev_up": 748.5, "invlev_dn": 748.5, "manhole_up": "manhole_490_generated", "manhole_dn": "manhole_491_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384936.622762819286436, 5858294.068231076002121 ], [ 1384984.637113286415115, 5858280.272530450485647 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.0, "elevtn_dn": 743.20001220703125, "invlev_up": 748.5, "invlev_dn": 740.70001220703125, "manhole_up": "manhole_491_generated", "manhole_dn": "manhole_492_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384984.637113286415115, 5858280.272530450485647 ], [ 1385032.633651287527755, 5858266.414710656739771 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 743.20001220703125, "elevtn_dn": 743.20001220703125, "invlev_up": 740.70001220703125, "invlev_dn": 740.70001220703125, "manhole_up": "manhole_492_generated", "manhole_dn": "manhole_493_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385032.633651287527755, 5858266.414710656739771 ], [ 1385081.886840383987874, 5858258.136644747108221 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 743.20001220703125, "elevtn_dn": 747.60003662109375, "invlev_up": 740.70001220703125, "invlev_dn": 745.10003662109375, "manhole_up": "manhole_493_generated", "manhole_dn": "manhole_494_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385081.886840383987874, 5858258.136644747108221 ], [ 1385131.310463621048257, 5858263.211211345158517 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.60003662109375, "elevtn_dn": 756.79998779296875, "invlev_up": 745.10003662109375, "invlev_dn": 754.29998779296875, "manhole_up": "manhole_494_generated", "manhole_dn": "manhole_495_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385131.310463621048257, 5858263.211211345158517 ], [ 1385177.729395114118233, 5858281.168494092300534 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.79998779296875, "elevtn_dn": 758.9000244140625, "invlev_up": 754.29998779296875, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_495_generated", "manhole_dn": "manhole_496_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385177.729395114118233, 5858281.168494092300534 ], [ 1385219.95651927171275, 5858307.84242575801909 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 758.9000244140625, "invlev_up": 756.4000244140625, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_496_generated", "manhole_dn": "manhole_497_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385219.95651927171275, 5858307.84242575801909 ], [ 1385261.864506913116202, 5858335.034840167500079 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 756.29998779296875, "invlev_up": 756.4000244140625, "invlev_dn": 753.79998779296875, "manhole_up": "manhole_497_generated", "manhole_dn": "manhole_498_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385261.864506913116202, 5858335.034840167500079 ], [ 1385305.658712412696332, 5858358.964500648900867 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 756.29998779296875, "invlev_up": 753.79998779296875, "invlev_dn": 753.79998779296875, "manhole_up": "manhole_498_generated", "manhole_dn": "manhole_499_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385305.658712412696332, 5858358.964500648900867 ], [ 1385350.136275847908109, 5858381.712097893469036 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 750.79998779296875, "invlev_up": 753.79998779296875, "invlev_dn": 748.29998779296875, "manhole_up": "manhole_499_generated", "manhole_dn": "manhole_500_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385350.136275847908109, 5858381.712097893469036 ], [ 1385394.617425152566284, 5858404.452682325616479 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 750.79998779296875, "elevtn_dn": 760.20001220703125, "invlev_up": 748.29998779296875, "invlev_dn": 757.70001220703125, "manhole_up": "manhole_500_generated", "manhole_dn": "manhole_501_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385394.617425152566284, 5858404.452682325616479 ], [ 1385439.245915542822331, 5858426.901898948475718 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 760.20001220703125, "elevtn_dn": 754.29998779296875, "invlev_up": 757.70001220703125, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_501_generated", "manhole_dn": "manhole_502_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385439.245915542822331, 5858426.901898948475718 ], [ 1385483.926139793125913, 5858449.248809035867453 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 754.29998779296875, "invlev_up": 751.79998779296875, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_502_generated", "manhole_dn": "manhole_503_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385483.926139793125913, 5858449.248809035867453 ], [ 1385525.860647091642022, 5858475.8632338559255 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 754.29998779296875, "invlev_up": 751.79998779296875, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_503_generated", "manhole_dn": "manhole_504_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385525.860647091642022, 5858475.8632338559255 ], [ 1385553.357332118786871, 5858517.404887572862208 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 751.70001220703125, "invlev_up": 751.79998779296875, "invlev_dn": 749.20001220703125, "manhole_up": "manhole_504_generated", "manhole_dn": "manhole_505_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385553.357332118786871, 5858517.404887572862208 ], [ 1385579.617479301057756, 5858559.686364834196866 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.70001220703125, "elevtn_dn": 751.70001220703125, "invlev_up": 749.20001220703125, "invlev_dn": 749.20001220703125, "manhole_up": "manhole_505_generated", "manhole_dn": "manhole_506_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385579.617479301057756, 5858559.686364834196866 ], [ 1385621.905693766893819, 5858585.068030893802643 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.70001220703125, "elevtn_dn": 750.9000244140625, "invlev_up": 749.20001220703125, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_506_generated", "manhole_dn": "manhole_507_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385621.905693766893819, 5858585.068030893802643 ], [ 1385664.027273919200525, 5858611.351026647724211 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 750.9000244140625, "invlev_up": 748.4000244140625, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_507_generated", "manhole_dn": "manhole_508_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385664.027273919200525, 5858611.351026647724211 ], [ 1385700.387205619364977, 5858645.507954810746014 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 750.9000244140625, "invlev_up": 748.4000244140625, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_508_generated", "manhole_dn": "manhole_509_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385700.387205619364977, 5858645.507954810746014 ], [ 1385734.601841112133116, 5858681.909404612146318 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 755.79998779296875, "invlev_up": 748.4000244140625, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_509_generated", "manhole_dn": "manhole_510_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385734.601841112133116, 5858681.909404612146318 ], [ 1385768.816476604901254, 5858718.310854412615299 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_510_generated", "manhole_dn": "manhole_511_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385768.816476604901254, 5858718.310854412615299 ], [ 1385802.200311921536922, 5858755.447309947572649 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_511_generated", "manhole_dn": "manhole_512_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385802.200311921536922, 5858755.447309947572649 ], [ 1385834.15946239954792, 5858793.844178703613579 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_21_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 765.0, "invlev_up": 753.79998779296875, "invlev_dn": 762.5, "manhole_up": "manhole_513_generated", "manhole_dn": "manhole_514_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385352.471788094611838, 5858398.70255031902343 ], [ 1385323.609449510695413, 5858430.098599229939282 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_21_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.0, "elevtn_dn": 765.0, "invlev_up": 762.5, "invlev_dn": 762.5, "manhole_up": "manhole_514_generated", "manhole_dn": "manhole_515_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385323.609449510695413, 5858430.098599229939282 ], [ 1385286.388775944709778, 5858419.306091710925102 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_21_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.0, "elevtn_dn": 758.9000244140625, "invlev_up": 762.5, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_515_generated", "manhole_dn": "manhole_516_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385286.388775944709778, 5858419.306091710925102 ], [ 1385252.458742934046313, 5858394.201654580421746 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_21_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 758.9000244140625, "invlev_up": 756.4000244140625, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_516_generated", "manhole_dn": "manhole_517_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385252.458742934046313, 5858394.201654580421746 ], [ 1385217.536378393415362, 5858369.72360460460186 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_21_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 756.79998779296875, "invlev_up": 756.4000244140625, "invlev_dn": 754.29998779296875, "manhole_up": "manhole_517_generated", "manhole_dn": "manhole_518_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385217.536378393415362, 5858369.72360460460186 ], [ 1385177.877519500209019, 5858363.975667187944055 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_23_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_23", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "manhole_up": "manhole_519_generated", "manhole_dn": "manhole_520_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384748.107251951703802, 5858475.46539437584579 ], [ 1384773.662756133358926, 5858482.028828926384449 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_23_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_23", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "manhole_up": "manhole_520_generated", "manhole_dn": "manhole_521_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384773.662756133358926, 5858482.028828926384449 ], [ 1384799.21826031524688, 5858488.592263477854431 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_24_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_24", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_24", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.9000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 760.4000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_522_generated", "manhole_dn": "manhole_523_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385831.554474999429658, 5858837.476550582796335 ], [ 1385834.933234154479578, 5858795.367517679929733 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_24_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_24", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_24", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 748.9000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_523_generated", "manhole_dn": "manhole_524_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385834.933234154479578, 5858795.367517679929733 ], [ 1385855.640895856311545, 5858836.135079927742481 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_25_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_25", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.79998779296875, "elevtn_dn": 791.20001220703125, "invlev_up": 784.29998779296875, "invlev_dn": 788.70001220703125, "manhole_up": "manhole_525_generated", "manhole_dn": "manhole_526_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385425.871741503709927, 5858809.522038951516151 ], [ 1385446.216239683330059, 5858844.397748519666493 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_25_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_25", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.20001220703125, "elevtn_dn": 791.20001220703125, "invlev_up": 788.70001220703125, "invlev_dn": 788.70001220703125, "manhole_up": "manhole_526_generated", "manhole_dn": "manhole_527_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385446.216239683330059, 5858844.397748519666493 ], [ 1385453.998638280900195, 5858886.437654017470777 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_25_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_25", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.20001220703125, "elevtn_dn": 783.0, "invlev_up": 788.70001220703125, "invlev_dn": 780.5, "manhole_up": "manhole_527_generated", "manhole_dn": "manhole_528_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385453.998638280900195, 5858886.437654017470777 ], [ 1385472.218053022632375, 5858925.273072509095073 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_26_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_26", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_26", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.9000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 760.4000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_522_generated", "manhole_dn": "manhole_524_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385831.554474999429658, 5858837.476550582796335 ], [ 1385855.640895856311545, 5858836.135079927742481 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_29_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_29", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_29", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_529_generated", "manhole_dn": "manhole_530_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385861.372513797832653, 5858893.832569030113518 ], [ 1385844.630084188189358, 5858865.848266057670116 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_29_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_29", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_29", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 762.9000244140625, "invlev_up": 757.20001220703125, "invlev_dn": 760.4000244140625, "manhole_up": "manhole_530_generated", "manhole_dn": "manhole_522_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385844.630084188189358, 5858865.848266057670116 ], [ 1385831.554474999429658, 5858837.476550582796335 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 769.4000244140625, "invlev_up": 766.9000244140625, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_531_generated", "manhole_dn": "manhole_532_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387137.22300889948383, 5858981.723106959834695 ], [ 1387148.04859330272302, 5859026.366797789931297 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 762.60003662109375, "invlev_up": 766.9000244140625, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_532_generated", "manhole_dn": "manhole_533_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387148.04859330272302, 5859026.366797789931297 ], [ 1387119.95937648974359, 5859056.934598693624139 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 762.60003662109375, "invlev_up": 760.10003662109375, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_533_generated", "manhole_dn": "manhole_534_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387119.95937648974359, 5859056.934598693624139 ], [ 1387074.832296247361228, 5859065.30100557859987 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 755.79998779296875, "invlev_up": 760.10003662109375, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_534_generated", "manhole_dn": "manhole_535_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387074.832296247361228, 5859065.30100557859987 ], [ 1387030.356415221933275, 5859076.86137125454843 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 772.4000244140625, "invlev_up": 753.29998779296875, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_535_generated", "manhole_dn": "manhole_536_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387030.356415221933275, 5859076.86137125454843 ], [ 1386986.427998587489128, 5859090.309648380614817 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 761.60003662109375, "invlev_up": 769.9000244140625, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_536_generated", "manhole_dn": "manhole_537_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386986.427998587489128, 5859090.309648380614817 ], [ 1386945.966695382725447, 5859111.788386604748666 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_537_generated", "manhole_dn": "manhole_538_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386945.966695382725447, 5859111.788386604748666 ], [ 1386905.77102447184734, 5859134.105928846634924 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_538_generated", "manhole_dn": "manhole_539_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386905.77102447184734, 5859134.105928846634924 ], [ 1386871.537448140559718, 5859162.609670763835311 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_539_generated", "manhole_dn": "manhole_540_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386871.537448140559718, 5859162.609670763835311 ], [ 1386921.106019288301468, 5859163.103915391489863 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 772.4000244140625, "invlev_up": 759.10003662109375, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_540_generated", "manhole_dn": "manhole_541_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386921.106019288301468, 5859163.103915391489863 ], [ 1386970.627896018791944, 5859161.624508504755795 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 772.4000244140625, "invlev_up": 769.9000244140625, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_541_generated", "manhole_dn": "manhole_542_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386970.627896018791944, 5859161.624508504755795 ], [ 1387019.993600395740941, 5859157.412991388700902 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 781.10003662109375, "invlev_up": 769.9000244140625, "invlev_dn": 778.60003662109375, "manhole_up": "manhole_542_generated", "manhole_dn": "manhole_543_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387019.993600395740941, 5859157.412991388700902 ], [ 1387069.191225855611265, 5859151.340004274621606 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 781.10003662109375, "elevtn_dn": 781.10003662109375, "invlev_up": 778.60003662109375, "invlev_dn": 778.60003662109375, "manhole_up": "manhole_543_generated", "manhole_dn": "manhole_544_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387069.191225855611265, 5859151.340004274621606 ], [ 1387118.547863835236058, 5859146.828392788767815 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 781.10003662109375, "elevtn_dn": 786.4000244140625, "invlev_up": 778.60003662109375, "invlev_dn": 783.9000244140625, "manhole_up": "manhole_544_generated", "manhole_dn": "manhole_545_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387118.547863835236058, 5859146.828392788767815 ], [ 1387167.916038708761334, 5859151.025294326245785 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.4000244140625, "elevtn_dn": 786.4000244140625, "invlev_up": 783.9000244140625, "invlev_dn": 783.9000244140625, "manhole_up": "manhole_545_generated", "manhole_dn": "manhole_546_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387167.916038708761334, 5859151.025294326245785 ], [ 1387217.282604865729809, 5859155.523034786805511 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.4000244140625, "elevtn_dn": 787.60003662109375, "invlev_up": 783.9000244140625, "invlev_dn": 785.10003662109375, "manhole_up": "manhole_546_generated", "manhole_dn": "manhole_547_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387217.282604865729809, 5859155.523034786805511 ], [ 1387266.649171022465453, 5859160.020775248296559 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.60003662109375, "elevtn_dn": 787.60003662109375, "invlev_up": 785.10003662109375, "invlev_dn": 785.10003662109375, "manhole_up": "manhole_547_generated", "manhole_dn": "manhole_548_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387266.649171022465453, 5859160.020775248296559 ], [ 1387315.831188223091885, 5859165.716172898188233 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.60003662109375, "elevtn_dn": 790.4000244140625, "invlev_up": 785.10003662109375, "invlev_dn": 787.9000244140625, "manhole_up": "manhole_548_generated", "manhole_dn": "manhole_549_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387315.831188223091885, 5859165.716172898188233 ], [ 1387364.261764668161049, 5859176.288154195994139 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 790.4000244140625, "elevtn_dn": 790.4000244140625, "invlev_up": 787.9000244140625, "invlev_dn": 787.9000244140625, "manhole_up": "manhole_549_generated", "manhole_dn": "manhole_550_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387364.261764668161049, 5859176.288154195994139 ], [ 1387411.186259990092367, 5859192.118345031514764 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 790.4000244140625, "elevtn_dn": 789.10003662109375, "invlev_up": 787.9000244140625, "invlev_dn": 786.60003662109375, "manhole_up": "manhole_550_generated", "manhole_dn": "manhole_551_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387411.186259990092367, 5859192.118345031514764 ], [ 1387455.544592748628929, 5859213.906051598489285 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 789.10003662109375, "elevtn_dn": 817.20001220703125, "invlev_up": 786.60003662109375, "invlev_dn": 814.70001220703125, "manhole_up": "manhole_551_generated", "manhole_dn": "manhole_552_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387455.544592748628929, 5859213.906051598489285 ], [ 1387490.610425172373652, 5859248.94134864397347 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 817.20001220703125, "elevtn_dn": 818.20001220703125, "invlev_up": 814.70001220703125, "invlev_dn": 815.70001220703125, "manhole_up": "manhole_552_generated", "manhole_dn": "manhole_553_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387490.610425172373652, 5859248.94134864397347 ], [ 1387525.979065561201423, 5859283.669168318621814 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.20001220703125, "elevtn_dn": 818.20001220703125, "invlev_up": 815.70001220703125, "invlev_dn": 815.70001220703125, "manhole_up": "manhole_553_generated", "manhole_dn": "manhole_554_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387525.979065561201423, 5859283.669168318621814 ], [ 1387563.532416822388768, 5859316.0270627560094 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.20001220703125, "elevtn_dn": 802.79998779296875, "invlev_up": 815.70001220703125, "invlev_dn": 800.29998779296875, "manhole_up": "manhole_554_generated", "manhole_dn": "manhole_555_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387563.532416822388768, 5859316.0270627560094 ], [ 1387601.085768083808944, 5859348.384957193396986 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.79998779296875, "elevtn_dn": 837.70001220703125, "invlev_up": 800.29998779296875, "invlev_dn": 835.20001220703125, "manhole_up": "manhole_555_generated", "manhole_dn": "manhole_556_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387601.085768083808944, 5859348.384957193396986 ], [ 1387638.639119345229119, 5859380.742851630784571 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 837.70001220703125, "elevtn_dn": 837.70001220703125, "invlev_up": 835.20001220703125, "invlev_dn": 835.20001220703125, "manhole_up": "manhole_556_generated", "manhole_dn": "manhole_557_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387638.639119345229119, 5859380.742851630784571 ], [ 1387676.192470606416464, 5859413.100746068172157 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 837.70001220703125, "elevtn_dn": 828.79998779296875, "invlev_up": 835.20001220703125, "invlev_dn": 826.29998779296875, "manhole_up": "manhole_557_generated", "manhole_dn": "manhole_558_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387676.192470606416464, 5859413.100746068172157 ], [ 1387713.745821867836639, 5859445.45864050462842 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 828.79998779296875, "elevtn_dn": 828.79998779296875, "invlev_up": 826.29998779296875, "invlev_dn": 826.29998779296875, "manhole_up": "manhole_558_generated", "manhole_dn": "manhole_559_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387713.745821867836639, 5859445.45864050462842 ], [ 1387750.394377880264074, 5859478.825171477161348 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 828.79998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 826.29998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_559_generated", "manhole_dn": "manhole_560_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387750.394377880264074, 5859478.825171477161348 ], [ 1387786.626276910537854, 5859512.656178202480078 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 851.79998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_560_generated", "manhole_dn": "manhole_561_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387786.626276910537854, 5859512.656178202480078 ], [ 1387822.858175940578803, 5859546.487184926867485 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 851.79998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_561_generated", "manhole_dn": "manhole_562_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387822.858175940578803, 5859546.487184926867485 ], [ 1387850.662340233800933, 5859586.980695966631174 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 891.20001220703125, "invlev_up": 851.79998779296875, "invlev_dn": 888.70001220703125, "manhole_up": "manhole_562_generated", "manhole_dn": "manhole_563_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387850.662340233800933, 5859586.980695966631174 ], [ 1387868.193221996771172, 5859633.330900657922029 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.20001220703125, "elevtn_dn": 876.20001220703125, "invlev_up": 888.70001220703125, "invlev_dn": 873.70001220703125, "manhole_up": "manhole_563_generated", "manhole_dn": "manhole_564_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387868.193221996771172, 5859633.330900657922029 ], [ 1387885.535610173596069, 5859679.769344814121723 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 876.20001220703125, "elevtn_dn": 876.20001220703125, "invlev_up": 873.70001220703125, "invlev_dn": 873.70001220703125, "manhole_up": "manhole_564_generated", "manhole_dn": "manhole_565_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387885.535610173596069, 5859679.769344814121723 ], [ 1387902.854485532967374, 5859726.216552678495646 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 876.20001220703125, "elevtn_dn": 898.29998779296875, "invlev_up": 873.70001220703125, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_565_generated", "manhole_dn": "manhole_566_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387902.854485532967374, 5859726.216552678495646 ], [ 1387920.137465380365029, 5859772.67713953461498 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 898.29998779296875, "invlev_up": 895.79998779296875, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_566_generated", "manhole_dn": "manhole_567_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387920.137465380365029, 5859772.67713953461498 ], [ 1387937.420445227529854, 5859819.137726389802992 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 898.29998779296875, "invlev_up": 895.79998779296875, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_567_generated", "manhole_dn": "manhole_568_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387937.420445227529854, 5859819.137726389802992 ], [ 1387948.863530882401392, 5859867.082766367122531 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 918.5, "invlev_up": 895.79998779296875, "invlev_dn": 916.0, "manhole_up": "manhole_568_generated", "manhole_dn": "manhole_569_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387948.863530882401392, 5859867.082766367122531 ], [ 1387950.013254075078294, 5859916.565449987538159 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 918.5, "invlev_up": 916.0, "invlev_dn": 916.0, "manhole_up": "manhole_569_generated", "manhole_dn": "manhole_570_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387950.013254075078294, 5859916.565449987538159 ], [ 1387947.430782878771424, 5859966.047936389222741 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 918.5, "invlev_up": 916.0, "invlev_dn": 916.0, "manhole_up": "manhole_570_generated", "manhole_dn": "manhole_571_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387947.430782878771424, 5859966.047936389222741 ], [ 1387943.997958281077445, 5860015.499966060742736 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 948.60003662109375, "invlev_up": 916.0, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_571_generated", "manhole_dn": "manhole_572_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387943.997958281077445, 5860015.499966060742736 ], [ 1387940.565133683150634, 5860064.951995733194053 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 948.60003662109375, "invlev_up": 946.10003662109375, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_572_generated", "manhole_dn": "manhole_573_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.565133683150634, 5860064.951995733194053 ], [ 1387945.371777657186612, 5860113.959104515612125 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 948.60003662109375, "invlev_up": 946.10003662109375, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_573_generated", "manhole_dn": "manhole_574_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387945.371777657186612, 5860113.959104515612125 ], [ 1387964.117816498270258, 5860159.736532494425774 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 940.5, "invlev_up": 946.10003662109375, "invlev_dn": 938.0, "manhole_up": "manhole_574_generated", "manhole_dn": "manhole_575_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387964.117816498270258, 5860159.736532494425774 ], [ 1387984.093857799191028, 5860205.104420888237655 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 940.5, "invlev_up": 938.0, "invlev_dn": 938.0, "manhole_up": "manhole_575_generated", "manhole_dn": "manhole_576_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387984.093857799191028, 5860205.104420888237655 ], [ 1388004.069899099878967, 5860250.472309282049537 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 940.5, "invlev_up": 938.0, "invlev_dn": 938.0, "manhole_up": "manhole_576_generated", "manhole_dn": "manhole_577_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388004.069899099878967, 5860250.472309282049537 ], [ 1388027.68692572391592, 5860293.896034284494817 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 971.70001220703125, "invlev_up": 938.0, "invlev_dn": 969.20001220703125, "manhole_up": "manhole_577_generated", "manhole_dn": "manhole_578_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388027.68692572391592, 5860293.896034284494817 ], [ 1388060.096315970877185, 5860331.348726416006684 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 971.70001220703125, "elevtn_dn": 935.5, "invlev_up": 969.20001220703125, "invlev_dn": 933.0, "manhole_up": "manhole_578_generated", "manhole_dn": "manhole_579_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388060.096315970877185, 5860331.348726416006684 ], [ 1388092.967688721138984, 5860368.453448176383972 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 935.5, "invlev_up": 933.0, "invlev_dn": 933.0, "manhole_up": "manhole_579_generated", "manhole_dn": "manhole_580_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388092.967688721138984, 5860368.453448176383972 ], [ 1388119.020827289205045, 5860410.510251956991851 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 949.9000244140625, "invlev_up": 933.0, "invlev_dn": 947.4000244140625, "manhole_up": "manhole_580_generated", "manhole_dn": "manhole_581_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388119.020827289205045, 5860410.510251956991851 ], [ 1388143.407622833969072, 5860453.667774203233421 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 949.9000244140625, "elevtn_dn": 924.60003662109375, "invlev_up": 947.4000244140625, "invlev_dn": 922.10003662109375, "manhole_up": "manhole_581_generated", "manhole_dn": "manhole_582_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388143.407622833969072, 5860453.667774203233421 ], [ 1388167.794418378733099, 5860496.82529644947499 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 924.60003662109375, "elevtn_dn": 924.60003662109375, "invlev_up": 922.10003662109375, "invlev_dn": 922.10003662109375, "manhole_up": "manhole_582_generated", "manhole_dn": "manhole_583_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388167.794418378733099, 5860496.82529644947499 ], [ 1388187.41186453984119, 5860542.097804954275489 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 924.60003662109375, "elevtn_dn": 942.4000244140625, "invlev_up": 922.10003662109375, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_583_generated", "manhole_dn": "manhole_584_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388187.41186453984119, 5860542.097804954275489 ], [ 1388193.385166377527639, 5860591.251542154699564 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 942.4000244140625, "invlev_up": 939.9000244140625, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_584_generated", "manhole_dn": "manhole_585_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388193.385166377527639, 5860591.251542154699564 ], [ 1388198.812296225922182, 5860640.524595490656793 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 942.4000244140625, "invlev_up": 939.9000244140625, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_585_generated", "manhole_dn": "manhole_586_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388198.812296225922182, 5860640.524595490656793 ], [ 1388204.239426074549556, 5860689.7976488256827 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 955.0, "invlev_up": 939.9000244140625, "invlev_dn": 952.5, "manhole_up": "manhole_586_generated", "manhole_dn": "manhole_587_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388204.239426074549556, 5860689.7976488256827 ], [ 1388184.484932377934456, 5860730.700381714850664 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E48", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_587_generated", "manhole_dn": "manhole_588_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388184.484932377934456, 5860730.700381714850664 ], [ 1388159.550175313837826, 5860759.392759991809726 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E49", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_588_generated", "manhole_dn": "manhole_589_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388159.550175313837826, 5860759.392759991809726 ], [ 1388171.988544700434431, 5860807.377908634953201 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E50", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_589_generated", "manhole_dn": "manhole_590_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388171.988544700434431, 5860807.377908634953201 ], [ 1388215.013825689908117, 5860825.214942933060229 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E51", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 941.10003662109375, "invlev_up": 952.5, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_590_generated", "manhole_dn": "manhole_591_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388215.013825689908117, 5860825.214942933060229 ], [ 1388264.397385431453586, 5860829.298032846301794 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E52", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_591_generated", "manhole_dn": "manhole_592_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388264.397385431453586, 5860829.298032846301794 ], [ 1388313.062299854354933, 5860837.304878970608115 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E53", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 937.5, "invlev_up": 938.60003662109375, "invlev_dn": 935.0, "manhole_up": "manhole_592_generated", "manhole_dn": "manhole_593_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388313.062299854354933, 5860837.304878970608115 ], [ 1388360.993895401246846, 5860849.948045967146754 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E54", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.5, "elevtn_dn": 937.5, "invlev_up": 935.0, "invlev_dn": 935.0, "manhole_up": "manhole_593_generated", "manhole_dn": "manhole_594_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388360.993895401246846, 5860849.948045967146754 ], [ 1388408.925490947905928, 5860862.591212964616716 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E55", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.5, "elevtn_dn": 937.60003662109375, "invlev_up": 935.0, "invlev_dn": 935.10003662109375, "manhole_up": "manhole_594_generated", "manhole_dn": "manhole_595_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388408.925490947905928, 5860862.591212964616716 ], [ 1388458.220990223577246, 5860866.957201769575477 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E56", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.60003662109375, "elevtn_dn": 937.60003662109375, "invlev_up": 935.10003662109375, "invlev_dn": 935.10003662109375, "manhole_up": "manhole_595_generated", "manhole_dn": "manhole_596_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388458.220990223577246, 5860866.957201769575477 ], [ 1388507.336333080893382, 5860873.218384950421751 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E57", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.60003662109375, "elevtn_dn": 941.20001220703125, "invlev_up": 935.10003662109375, "invlev_dn": 938.70001220703125, "manhole_up": "manhole_596_generated", "manhole_dn": "manhole_597_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388507.336333080893382, 5860873.218384950421751 ], [ 1388556.215695114107803, 5860881.470384138636291 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E58", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.20001220703125, "elevtn_dn": 941.20001220703125, "invlev_up": 938.70001220703125, "invlev_dn": 938.70001220703125, "manhole_up": "manhole_597_generated", "manhole_dn": "manhole_598_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388556.215695114107803, 5860881.470384138636291 ], [ 1388604.556662159739062, 5860892.361969010904431 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E59", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.20001220703125, "elevtn_dn": 943.10003662109375, "invlev_up": 938.70001220703125, "invlev_dn": 940.60003662109375, "manhole_up": "manhole_598_generated", "manhole_dn": "manhole_599_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388604.556662159739062, 5860892.361969010904431 ], [ 1388653.59940263046883, 5860897.15789801068604 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E60", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 943.10003662109375, "elevtn_dn": 943.10003662109375, "invlev_up": 940.60003662109375, "invlev_dn": 940.60003662109375, "manhole_up": "manhole_599_generated", "manhole_dn": "manhole_600_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388653.59940263046883, 5860897.15789801068604 ], [ 1388700.080393208190799, 5860881.090511013753712 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E61", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 943.10003662109375, "elevtn_dn": 946.10003662109375, "invlev_up": 940.60003662109375, "invlev_dn": 943.60003662109375, "manhole_up": "manhole_600_generated", "manhole_dn": "manhole_601_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388700.080393208190799, 5860881.090511013753712 ], [ 1388732.687003659084439, 5860844.794781206175685 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E62", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 946.10003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 943.60003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_601_generated", "manhole_dn": "manhole_602_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388732.687003659084439, 5860844.794781206175685 ], [ 1388755.953327334951609, 5860801.023035684600472 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E63", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 950.10003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_602_generated", "manhole_dn": "manhole_603_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388755.953327334951609, 5860801.023035684600472 ], [ 1388778.23369869007729, 5860756.84024004638195 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E64", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 950.10003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_603_generated", "manhole_dn": "manhole_604_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388778.23369869007729, 5860756.84024004638195 ], [ 1388792.950793598080054, 5860709.504263866692781 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E65", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 953.79998779296875, "invlev_up": 950.10003662109375, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_604_generated", "manhole_dn": "manhole_605_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388792.950793598080054, 5860709.504263866692781 ], [ 1388807.667888506315649, 5860662.168287687934935 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E66", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_605_generated", "manhole_dn": "manhole_606_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388807.667888506315649, 5860662.168287687934935 ], [ 1388819.224422588944435, 5860613.968191100284457 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E67", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 955.70001220703125, "invlev_up": 951.29998779296875, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_606_generated", "manhole_dn": "manhole_607_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388819.224422588944435, 5860613.968191100284457 ], [ 1388830.63825476472266, 5860565.72907877061516 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E68", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_607_generated", "manhole_dn": "manhole_608_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388830.63825476472266, 5860565.72907877061516 ], [ 1388842.052086940500885, 5860517.489966440014541 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E69", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_608_generated", "manhole_dn": "manhole_609_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388842.052086940500885, 5860517.489966440014541 ], [ 1388862.77624000934884, 5860472.578981296159327 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E70", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 964.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_609_generated", "manhole_dn": "manhole_610_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388862.77624000934884, 5860472.578981296159327 ], [ 1388884.529400010826066, 5860428.03588358964771 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E71", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 951.29998779296875, "invlev_up": 962.20001220703125, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_610_generated", "manhole_dn": "manhole_611_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388884.529400010826066, 5860428.03588358964771 ], [ 1388906.282637836178765, 5860383.492823889479041 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E72", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_611_generated", "manhole_dn": "manhole_612_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388906.282637836178765, 5860383.492823889479041 ], [ 1388933.946375871310011, 5860342.419800435192883 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E73", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_612_generated", "manhole_dn": "manhole_613_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388933.946375871310011, 5860342.419800435192883 ], [ 1388962.240715913940221, 5860301.717001453973353 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 752.29998779296875, "invlev_up": 759.10003662109375, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_539_generated", "manhole_dn": "manhole_614_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386871.537448140559718, 5859162.609670763835311 ], [ 1386825.19834817154333, 5859175.156894122250378 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 752.29998779296875, "invlev_up": 749.79998779296875, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_614_generated", "manhole_dn": "manhole_615_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386825.19834817154333, 5859175.156894122250378 ], [ 1386779.333999397465959, 5859189.44842192158103 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 738.0, "invlev_up": 749.79998779296875, "invlev_dn": 735.5, "manhole_up": "manhole_615_generated", "manhole_dn": "manhole_616_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386779.333999397465959, 5859189.44842192158103 ], [ 1386733.445003136992455, 5859203.660136871039867 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 738.0, "invlev_up": 735.5, "invlev_dn": 735.5, "manhole_up": "manhole_616_generated", "manhole_dn": "manhole_617_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386733.445003136992455, 5859203.660136871039867 ], [ 1386687.508546756347641, 5859217.718167688697577 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 763.29998779296875, "invlev_up": 735.5, "invlev_dn": 760.79998779296875, "manhole_up": "manhole_617_generated", "manhole_dn": "manhole_618_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386687.508546756347641, 5859217.718167688697577 ], [ 1386641.572090375469998, 5859231.776198507286608 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 763.29998779296875, "elevtn_dn": 763.29998779296875, "invlev_up": 760.79998779296875, "invlev_dn": 760.79998779296875, "manhole_up": "manhole_618_generated", "manhole_dn": "manhole_619_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386641.572090375469998, 5859231.776198507286608 ], [ 1386595.451642262749374, 5859245.168246414512396 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 763.29998779296875, "elevtn_dn": 754.60003662109375, "invlev_up": 760.79998779296875, "invlev_dn": 752.10003662109375, "manhole_up": "manhole_619_generated", "manhole_dn": "manhole_620_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386595.451642262749374, 5859245.168246414512396 ], [ 1386548.813360751140863, 5859256.685926430858672 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.60003662109375, "elevtn_dn": 754.60003662109375, "invlev_up": 752.10003662109375, "invlev_dn": 752.10003662109375, "manhole_up": "manhole_620_generated", "manhole_dn": "manhole_621_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386548.813360751140863, 5859256.685926430858672 ], [ 1386502.175079239532351, 5859268.203606447204947 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.60003662109375, "elevtn_dn": 742.5, "invlev_up": 752.10003662109375, "invlev_dn": 740.0, "manhole_up": "manhole_621_generated", "manhole_dn": "manhole_622_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386502.175079239532351, 5859268.203606447204947 ], [ 1386455.354356503346935, 5859278.943273726850748 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 742.5, "invlev_up": 740.0, "invlev_dn": 740.0, "manhole_up": "manhole_622_generated", "manhole_dn": "manhole_623_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386455.354356503346935, 5859278.943273726850748 ], [ 1386408.879239794565365, 5859290.671229789964855 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 717.60003662109375, "invlev_up": 740.0, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_623_generated", "manhole_dn": "manhole_624_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386408.879239794565365, 5859290.671229789964855 ], [ 1386364.691368696978316, 5859309.518465746194124 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 717.60003662109375, "invlev_up": 715.10003662109375, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_624_generated", "manhole_dn": "manhole_625_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386364.691368696978316, 5859309.518465746194124 ], [ 1386320.503497599391267, 5859328.365701701492071 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 711.0, "invlev_up": 715.10003662109375, "invlev_dn": 708.5, "manhole_up": "manhole_625_generated", "manhole_dn": "manhole_626_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386320.503497599391267, 5859328.365701701492071 ], [ 1386273.173811787506565, 5859335.36546028777957 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 953.70001220703125, "invlev_up": 948.79998779296875, "invlev_dn": 951.20001220703125, "manhole_up": "manhole_10_generated", "manhole_dn": "manhole_627_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388946.301100668497384, 5860414.883977899327874 ], [ 1388922.246059404918924, 5860458.418739438988268 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.70001220703125, "elevtn_dn": 953.70001220703125, "invlev_up": 951.20001220703125, "invlev_dn": 951.20001220703125, "manhole_up": "manhole_627_generated", "manhole_dn": "manhole_628_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388922.246059404918924, 5860458.418739438988268 ], [ 1388900.295977992936969, 5860503.075897979550064 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 951.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_628_generated", "manhole_dn": "manhole_629_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388900.295977992936969, 5860503.075897979550064 ], [ 1388878.345896581187844, 5860547.733056520111859 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 953.79998779296875, "invlev_up": 953.20001220703125, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_629_generated", "manhole_dn": "manhole_630_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388878.345896581187844, 5860547.733056520111859 ], [ 1388856.887740465346724, 5860592.570927501656115 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_630_generated", "manhole_dn": "manhole_631_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388856.887740465346724, 5860592.570927501656115 ], [ 1388853.076019846601412, 5860641.795407227240503 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_631_generated", "manhole_dn": "manhole_632_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388853.076019846601412, 5860641.795407227240503 ], [ 1388856.119826921960339, 5860691.462329030036926 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 952.5, "invlev_up": 951.29998779296875, "invlev_dn": 950.0, "manhole_up": "manhole_632_generated", "manhole_dn": "manhole_633_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388856.119826921960339, 5860691.462329030036926 ], [ 1388859.163633997086436, 5860741.12925083283335 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.5, "elevtn_dn": 952.5, "invlev_up": 950.0, "invlev_dn": 950.0, "manhole_up": "manhole_633_generated", "manhole_dn": "manhole_634_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388859.163633997086436, 5860741.12925083283335 ], [ 1388862.207441072445363, 5860790.796172635629773 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.5, "elevtn_dn": 945.5, "invlev_up": 950.0, "invlev_dn": 943.0, "manhole_up": "manhole_634_generated", "manhole_dn": "manhole_635_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388862.207441072445363, 5860790.796172635629773 ], [ 1388866.356326055014506, 5860840.344227194786072 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 945.5, "invlev_up": 943.0, "invlev_dn": 943.0, "manhole_up": "manhole_635_generated", "manhole_dn": "manhole_636_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388866.356326055014506, 5860840.344227194786072 ], [ 1388873.944740658160299, 5860889.522310186177492 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 945.5, "invlev_up": 943.0, "invlev_dn": 943.0, "manhole_up": "manhole_636_generated", "manhole_dn": "manhole_637_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388873.944740658160299, 5860889.522310186177492 ], [ 1388883.17427325528115, 5860938.398467163555324 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 937.4000244140625, "invlev_up": 943.0, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_637_generated", "manhole_dn": "manhole_638_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388883.17427325528115, 5860938.398467163555324 ], [ 1388890.216840920504183, 5860987.212368851527572 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 937.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_638_generated", "manhole_dn": "manhole_639_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388890.216840920504183, 5860987.212368851527572 ], [ 1388884.322194910608232, 5861036.62209493201226 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 937.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_639_generated", "manhole_dn": "manhole_640_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388884.322194910608232, 5861036.62209493201226 ], [ 1388878.427548900712281, 5861086.031821011565626 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_640_generated", "manhole_dn": "manhole_641_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388878.427548900712281, 5861086.031821011565626 ], [ 1388872.532902890816331, 5861135.441547092050314 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 927.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_641_generated", "manhole_dn": "manhole_642_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388872.532902890816331, 5861135.441547092050314 ], [ 1388866.63825688092038, 5861184.851273172535002 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 927.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_642_generated", "manhole_dn": "manhole_643_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388866.63825688092038, 5861184.851273172535002 ], [ 1388854.620840607210994, 5861232.489912945777178 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 926.60003662109375, "invlev_up": 927.9000244140625, "invlev_dn": 924.10003662109375, "manhole_up": "manhole_643_generated", "manhole_dn": "manhole_644_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388854.620840607210994, 5861232.489912945777178 ], [ 1388833.22756120422855, 5861277.416469449177384 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 926.60003662109375, "elevtn_dn": 926.60003662109375, "invlev_up": 924.10003662109375, "invlev_dn": 924.10003662109375, "manhole_up": "manhole_644_generated", "manhole_dn": "manhole_645_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388833.22756120422855, 5861277.416469449177384 ], [ 1388811.834281801246107, 5861322.343025953508914 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 926.60003662109375, "elevtn_dn": 931.10003662109375, "invlev_up": 924.10003662109375, "invlev_dn": 928.60003662109375, "manhole_up": "manhole_645_generated", "manhole_dn": "manhole_646_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388811.834281801246107, 5861322.343025953508914 ], [ 1388790.441002398030832, 5861367.26958245690912 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 931.10003662109375, "elevtn_dn": 922.20001220703125, "invlev_up": 928.60003662109375, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_646_generated", "manhole_dn": "manhole_647_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388790.441002398030832, 5861367.26958245690912 ], [ 1388769.047722995048389, 5861412.196138960309327 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 922.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_647_generated", "manhole_dn": "manhole_648_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388769.047722995048389, 5861412.196138960309327 ], [ 1388747.654443592065945, 5861457.122695464640856 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 922.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_648_generated", "manhole_dn": "manhole_649_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388747.654443592065945, 5861457.122695464640856 ], [ 1388725.026126575190574, 5861501.410491958260536 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_649_generated", "manhole_dn": "manhole_650_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388725.026126575190574, 5861501.410491958260536 ], [ 1388700.725248141447082, 5861544.833241644315422 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_650_generated", "manhole_dn": "manhole_651_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388700.725248141447082, 5861544.833241644315422 ], [ 1388676.42436970770359, 5861588.255991329438984 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_651_generated", "manhole_dn": "manhole_652_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388676.42436970770359, 5861588.255991329438984 ], [ 1388632.324464634526521, 5861606.441272142343223 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 898.4000244140625, "invlev_up": 897.70001220703125, "invlev_dn": 895.9000244140625, "manhole_up": "manhole_652_generated", "manhole_dn": "manhole_653_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388632.324464634526521, 5861606.441272142343223 ], [ 1388583.463808472501114, 5861611.105615227483213 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.4000244140625, "elevtn_dn": 898.4000244140625, "invlev_up": 895.9000244140625, "invlev_dn": 895.9000244140625, "manhole_up": "manhole_653_generated", "manhole_dn": "manhole_654_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388583.463808472501114, 5861611.105615227483213 ], [ 1388534.764012826373801, 5861604.222017968073487 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.4000244140625, "elevtn_dn": 903.60003662109375, "invlev_up": 895.9000244140625, "invlev_dn": 901.10003662109375, "manhole_up": "manhole_654_generated", "manhole_dn": "manhole_655_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388534.764012826373801, 5861604.222017968073487 ], [ 1388489.566489090910181, 5861583.40731808822602 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 903.60003662109375, "elevtn_dn": 903.60003662109375, "invlev_up": 901.10003662109375, "invlev_dn": 901.10003662109375, "manhole_up": "manhole_655_generated", "manhole_dn": "manhole_656_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388489.566489090910181, 5861583.40731808822602 ], [ 1388444.204915680922568, 5861563.162508152425289 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 903.60003662109375, "elevtn_dn": 906.4000244140625, "invlev_up": 901.10003662109375, "invlev_dn": 903.9000244140625, "manhole_up": "manhole_656_generated", "manhole_dn": "manhole_657_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388444.204915680922568, 5861563.162508152425289 ], [ 1388394.858231473481283, 5861556.761520680040121 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 906.4000244140625, "elevtn_dn": 906.4000244140625, "invlev_up": 903.9000244140625, "invlev_dn": 903.9000244140625, "manhole_up": "manhole_657_generated", "manhole_dn": "manhole_658_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388394.858231473481283, 5861556.761520680040121 ], [ 1388350.680838279658929, 5861570.408674017526209 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 906.4000244140625, "elevtn_dn": 900.20001220703125, "invlev_up": 903.9000244140625, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_658_generated", "manhole_dn": "manhole_659_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388350.680838279658929, 5861570.408674017526209 ], [ 1388310.581732882419601, 5861599.872713611461222 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_659_generated", "manhole_dn": "manhole_660_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388310.581732882419601, 5861599.872713611461222 ], [ 1388271.039625711739063, 5861629.969603477045894 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 890.0, "invlev_up": 897.70001220703125, "invlev_dn": 887.5, "manhole_up": "manhole_660_generated", "manhole_dn": "manhole_661_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388271.039625711739063, 5861629.969603477045894 ], [ 1388236.722210306907073, 5861666.002683873288333 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 890.0, "invlev_up": 887.5, "invlev_dn": 887.5, "manhole_up": "manhole_661_generated", "manhole_dn": "manhole_662_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388236.722210306907073, 5861666.002683873288333 ], [ 1388202.404794902307913, 5861702.035764269530773 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 890.0, "invlev_up": 887.5, "invlev_dn": 887.5, "manhole_up": "manhole_662_generated", "manhole_dn": "manhole_663_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388202.404794902307913, 5861702.035764269530773 ], [ 1388168.087379497475922, 5861738.068844665773213 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 885.9000244140625, "invlev_up": 887.5, "invlev_dn": 883.4000244140625, "manhole_up": "manhole_663_generated", "manhole_dn": "manhole_664_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388168.087379497475922, 5861738.068844665773213 ], [ 1388133.769964092643932, 5861774.101925062015653 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 885.9000244140625, "elevtn_dn": 874.0, "invlev_up": 883.4000244140625, "invlev_dn": 871.5, "manhole_up": "manhole_664_generated", "manhole_dn": "manhole_665_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388133.769964092643932, 5861774.101925062015653 ], [ 1388099.452548687811941, 5861810.13500545732677 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 874.0, "elevtn_dn": 874.0, "invlev_up": 871.5, "invlev_dn": 871.5, "manhole_up": "manhole_665_generated", "manhole_dn": "manhole_666_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388099.452548687811941, 5861810.13500545732677 ], [ 1388065.135133283212781, 5861846.16808585356921 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 874.0, "elevtn_dn": 862.20001220703125, "invlev_up": 871.5, "invlev_dn": 859.70001220703125, "manhole_up": "manhole_666_generated", "manhole_dn": "manhole_667_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388065.135133283212781, 5861846.16808585356921 ], [ 1388022.995196633273736, 5861866.899685021489859 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 862.20001220703125, "elevtn_dn": 862.20001220703125, "invlev_up": 859.70001220703125, "invlev_dn": 859.70001220703125, "manhole_up": "manhole_667_generated", "manhole_dn": "manhole_668_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388022.995196633273736, 5861866.899685021489859 ], [ 1387973.690499771386385, 5861873.616436487063766 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 862.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 859.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_668_generated", "manhole_dn": "manhole_669_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387973.690499771386385, 5861873.616436487063766 ], [ 1387924.470484273741022, 5861880.90659652557224 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_669_generated", "manhole_dn": "manhole_670_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387924.470484273741022, 5861880.90659652557224 ], [ 1387877.962616891367361, 5861896.157046243548393 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_670_generated", "manhole_dn": "manhole_671_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387877.962616891367361, 5861896.157046243548393 ], [ 1387917.070526217576116, 5861911.915829903446138 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_671_generated", "manhole_dn": "manhole_672_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387917.070526217576116, 5861911.915829903446138 ], [ 1387966.654667611001059, 5861916.096835186704993 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 846.29998779296875, "invlev_up": 856.70001220703125, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_672_generated", "manhole_dn": "manhole_673_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387966.654667611001059, 5861916.096835186704993 ], [ 1388016.318005530629307, 5861919.063731476664543 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 850.10003662109375, "invlev_up": 843.79998779296875, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_673_generated", "manhole_dn": "manhole_674_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388016.318005530629307, 5861919.063731476664543 ], [ 1388066.025120510486886, 5861921.359510923735797 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E48", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 850.10003662109375, "invlev_up": 847.60003662109375, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_674_generated", "manhole_dn": "manhole_675_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388066.025120510486886, 5861921.359510923735797 ], [ 1388115.732235490344465, 5861923.655290370807052 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E49", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 849.0, "invlev_up": 847.60003662109375, "invlev_dn": 846.5, "manhole_up": "manhole_675_generated", "manhole_dn": "manhole_676_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388115.732235490344465, 5861923.655290370807052 ], [ 1388161.130695321131498, 5861931.457672152668238 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E50", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 849.0, "elevtn_dn": 850.10003662109375, "invlev_up": 846.5, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_676_generated", "manhole_dn": "manhole_677_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388161.130695321131498, 5861931.457672152668238 ], [ 1388139.871223766123876, 5861964.082641129381955 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E51", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 850.10003662109375, "invlev_up": 847.60003662109375, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_677_generated", "manhole_dn": "manhole_678_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388139.871223766123876, 5861964.082641129381955 ], [ 1388090.726845995755866, 5861957.769498392008245 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E52", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 846.29998779296875, "invlev_up": 847.60003662109375, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_678_generated", "manhole_dn": "manhole_679_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388090.726845995755866, 5861957.769498392008245 ], [ 1388049.339104855433106, 5861983.736727176234126 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E53", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 846.29998779296875, "invlev_up": 843.79998779296875, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_679_generated", "manhole_dn": "manhole_680_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388049.339104855433106, 5861983.736727176234126 ], [ 1388024.713075590552762, 5862026.975905770435929 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E54", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 846.29998779296875, "invlev_up": 843.79998779296875, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_680_generated", "manhole_dn": "manhole_681_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388024.713075590552762, 5862026.975905770435929 ], [ 1387980.016218039905652, 5862047.702198376879096 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E55", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 793.5, "invlev_up": 843.79998779296875, "invlev_dn": 791.0, "manhole_up": "manhole_681_generated", "manhole_dn": "manhole_682_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387980.016218039905652, 5862047.702198376879096 ], [ 1387931.90673128189519, 5862056.853296543471515 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E56", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.5, "elevtn_dn": 793.5, "invlev_up": 791.0, "invlev_dn": 791.0, "manhole_up": "manhole_682_generated", "manhole_dn": "manhole_683_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387931.90673128189519, 5862056.853296543471515 ], [ 1387882.187313467729837, 5862058.865105460397899 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E57", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.5, "elevtn_dn": 793.20001220703125, "invlev_up": 791.0, "invlev_dn": 790.70001220703125, "manhole_up": "manhole_683_generated", "manhole_dn": "manhole_684_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387882.187313467729837, 5862058.865105460397899 ], [ 1387832.722497318405658, 5862057.3410848621279 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E58", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.20001220703125, "elevtn_dn": 830.29998779296875, "invlev_up": 790.70001220703125, "invlev_dn": 827.79998779296875, "manhole_up": "manhole_684_generated", "manhole_dn": "manhole_685_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387832.722497318405658, 5862057.3410848621279 ], [ 1387783.80423084856011, 5862048.226750630885363 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E59", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.29998779296875, "elevtn_dn": 817.70001220703125, "invlev_up": 827.79998779296875, "invlev_dn": 815.20001220703125, "manhole_up": "manhole_685_generated", "manhole_dn": "manhole_686_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387783.80423084856011, 5862048.226750630885363 ], [ 1387734.885964378714561, 5862039.112416399642825 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E60", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 817.70001220703125, "elevtn_dn": 813.70001220703125, "invlev_up": 815.20001220703125, "invlev_dn": 811.20001220703125, "manhole_up": "manhole_686_generated", "manhole_dn": "manhole_687_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387734.885964378714561, 5862039.112416399642825 ], [ 1387685.967697908869013, 5862029.998082168400288 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E61", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 813.70001220703125, "elevtn_dn": 813.70001220703125, "invlev_up": 811.20001220703125, "invlev_dn": 811.20001220703125, "manhole_up": "manhole_687_generated", "manhole_dn": "manhole_688_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387685.967697908869013, 5862029.998082168400288 ], [ 1387637.036115845199674, 5862020.957140567712486 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E62", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 813.70001220703125, "elevtn_dn": 807.0, "invlev_up": 811.20001220703125, "invlev_dn": 804.5, "manhole_up": "manhole_688_generated", "manhole_dn": "manhole_689_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387637.036115845199674, 5862020.957140567712486 ], [ 1387588.033849656581879, 5862012.305794355459511 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E63", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.0, "elevtn_dn": 807.0, "invlev_up": 804.5, "invlev_dn": 804.5, "manhole_up": "manhole_689_generated", "manhole_dn": "manhole_690_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387588.033849656581879, 5862012.305794355459511 ], [ 1387539.031583468196914, 5862003.654448143206537 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E64", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.0, "elevtn_dn": 793.10003662109375, "invlev_up": 804.5, "invlev_dn": 790.60003662109375, "manhole_up": "manhole_690_generated", "manhole_dn": "manhole_691_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387539.031583468196914, 5862003.654448143206537 ], [ 1387490.029317279579118, 5861995.003101930953562 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E65", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.10003662109375, "elevtn_dn": 793.10003662109375, "invlev_up": 790.60003662109375, "invlev_dn": 790.60003662109375, "manhole_up": "manhole_691_generated", "manhole_dn": "manhole_692_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387490.029317279579118, 5861995.003101930953562 ], [ 1387440.720367865404114, 5861989.908138634636998 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E66", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.10003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 790.60003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_692_generated", "manhole_dn": "manhole_693_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387440.720367865404114, 5861989.908138634636998 ], [ 1387390.960446665296331, 5861990.042768024839461 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E67", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_693_generated", "manhole_dn": "manhole_694_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387390.960446665296331, 5861990.042768024839461 ], [ 1387341.200525465421379, 5861990.177397414110601 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E68", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 749.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 747.10003662109375, "manhole_up": "manhole_694_generated", "manhole_dn": "manhole_695_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387341.200525465421379, 5861990.177397414110601 ], [ 1387291.440604265546426, 5861990.312026804313064 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E69", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 749.60003662109375, "elevtn_dn": 749.60003662109375, "invlev_up": 747.10003662109375, "invlev_dn": 747.10003662109375, "manhole_up": "manhole_695_generated", "manhole_dn": "manhole_696_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387291.440604265546426, 5861990.312026804313064 ], [ 1387246.706285298336297, 5861974.212805554270744 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E70", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 749.60003662109375, "elevtn_dn": 747.0, "invlev_up": 747.10003662109375, "invlev_dn": 744.5, "manhole_up": "manhole_696_generated", "manhole_dn": "manhole_697_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387246.706285298336297, 5861974.212805554270744 ], [ 1387205.725988702848554, 5861945.987228964455426 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E71", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.0, "elevtn_dn": 771.79998779296875, "invlev_up": 744.5, "invlev_dn": 769.29998779296875, "manhole_up": "manhole_697_generated", "manhole_dn": "manhole_698_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387205.725988702848554, 5861945.987228964455426 ], [ 1387164.745692107127979, 5861917.761652374640107 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E72", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.79998779296875, "elevtn_dn": 764.10003662109375, "invlev_up": 769.29998779296875, "invlev_dn": 761.60003662109375, "manhole_up": "manhole_698_generated", "manhole_dn": "manhole_699_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387164.745692107127979, 5861917.761652374640107 ], [ 1387115.569933785125613, 5861911.215812381356955 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E73", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.10003662109375, "elevtn_dn": 764.10003662109375, "invlev_up": 761.60003662109375, "invlev_dn": 761.60003662109375, "manhole_up": "manhole_699_generated", "manhole_dn": "manhole_700_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387115.569933785125613, 5861911.215812381356955 ], [ 1387066.165866439929232, 5861905.273926095105708 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E74", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.10003662109375, "elevtn_dn": 747.70001220703125, "invlev_up": 761.60003662109375, "invlev_dn": 745.20001220703125, "manhole_up": "manhole_700_generated", "manhole_dn": "manhole_701_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387066.165866439929232, 5861905.273926095105708 ], [ 1387016.666836149292067, 5861900.238133460283279 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E75", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.70001220703125, "elevtn_dn": 747.70001220703125, "invlev_up": 745.20001220703125, "invlev_dn": 745.20001220703125, "manhole_up": "manhole_701_generated", "manhole_dn": "manhole_702_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387016.666836149292067, 5861900.238133460283279 ], [ 1386975.698310127714649, 5861874.842493440955877 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E76", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.70001220703125, "elevtn_dn": 739.60003662109375, "invlev_up": 745.20001220703125, "invlev_dn": 737.10003662109375, "manhole_up": "manhole_702_generated", "manhole_dn": "manhole_703_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386975.698310127714649, 5861874.842493440955877 ], [ 1386937.286019780673087, 5861843.21080310922116 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E77", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.60003662109375, "elevtn_dn": 739.60003662109375, "invlev_up": 737.10003662109375, "invlev_dn": 737.10003662109375, "manhole_up": "manhole_703_generated", "manhole_dn": "manhole_704_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386937.286019780673087, 5861843.21080310922116 ], [ 1386898.873729433864355, 5861811.579112778417766 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E78", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.60003662109375, "elevtn_dn": 755.20001220703125, "invlev_up": 737.10003662109375, "invlev_dn": 752.70001220703125, "manhole_up": "manhole_704_generated", "manhole_dn": "manhole_705_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386898.873729433864355, 5861811.579112778417766 ], [ 1386860.461439087055624, 5861779.947422447614372 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E79", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.20001220703125, "elevtn_dn": 745.29998779296875, "invlev_up": 752.70001220703125, "invlev_dn": 742.79998779296875, "manhole_up": "manhole_705_generated", "manhole_dn": "manhole_706_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386860.461439087055624, 5861779.947422447614372 ], [ 1386822.049148740014061, 5861748.315732115879655 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E80", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 745.29998779296875, "elevtn_dn": 745.29998779296875, "invlev_up": 742.79998779296875, "invlev_dn": 742.79998779296875, "manhole_up": "manhole_706_generated", "manhole_dn": "manhole_707_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386822.049148740014061, 5861748.315732115879655 ], [ 1386774.418702265014872, 5861733.958941764198244 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E81", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 745.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 742.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_707_generated", "manhole_dn": "manhole_708_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386774.418702265014872, 5861733.958941764198244 ], [ 1386726.75721522886306, 5861719.660321676172316 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E82", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_708_generated", "manhole_dn": "manhole_709_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386726.75721522886306, 5861719.660321676172316 ], [ 1386681.211287560872734, 5861700.510515534318984 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E83", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 777.9000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_709_generated", "manhole_dn": "manhole_710_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386681.211287560872734, 5861700.510515534318984 ], [ 1386655.081909105414525, 5861659.807657876051962 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E84", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 758.79998779296875, "invlev_up": 775.4000244140625, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_710_generated", "manhole_dn": "manhole_711_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386655.081909105414525, 5861659.807657876051962 ], [ 1386647.41175345890224, 5861610.757949161343277 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E85", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_711_generated", "manhole_dn": "manhole_712_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386647.41175345890224, 5861610.757949161343277 ], [ 1386641.745189253240824, 5861561.363539570011199 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E86", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 732.4000244140625, "invlev_up": 756.29998779296875, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_712_generated", "manhole_dn": "manhole_713_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386641.745189253240824, 5861561.363539570011199 ], [ 1386642.37134926696308, 5861511.607376066967845 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E87", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_713_generated", "manhole_dn": "manhole_714_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386642.37134926696308, 5861511.607376066967845 ], [ 1386642.997509280918166, 5861461.851212563924491 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E88", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_714_generated", "manhole_dn": "manhole_715_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386642.997509280918166, 5861461.851212563924491 ], [ 1386643.623669294640422, 5861412.09504906181246 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E89", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 724.29998779296875, "invlev_up": 729.9000244140625, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_715_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386643.623669294640422, 5861412.09504906181246 ], [ 1386648.271799877518788, 5861347.644815167412162 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_35_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_35", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_35", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_716_generated", "manhole_dn": "manhole_717_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386060.978602184914052, 5859873.390328846871853 ], [ 1386078.54455375042744, 5859857.065600479952991 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_35_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_35", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_35", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_717_generated", "manhole_dn": "manhole_718_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386078.54455375042744, 5859857.065600479952991 ], [ 1386079.86695942771621, 5859885.500408614054322 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_36_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_36", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_36", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_719_generated", "manhole_dn": "manhole_716_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386030.926458492642269, 5859869.881591100245714 ], [ 1386060.978602184914052, 5859873.390328846871853 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_37_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_37", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_37", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_720_generated", "manhole_dn": "manhole_716_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386043.381105761509389, 5859908.11929196305573 ], [ 1386060.978602184914052, 5859873.390328846871853 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_38_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_38", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_718_generated", "manhole_dn": "manhole_721_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386079.86695942771621, 5859885.500408614054322 ], [ 1386081.40363402524963, 5859934.756705570034683 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_38_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_38", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_721_generated", "manhole_dn": "manhole_722_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386081.40363402524963, 5859934.756705570034683 ], [ 1386080.471781946951523, 5859983.948014200665057 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_38_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_38", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 756.5, "invlev_up": 763.79998779296875, "invlev_dn": 754.0, "manhole_up": "manhole_722_generated", "manhole_dn": "manhole_723_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386080.471781946951523, 5859983.948014200665057 ], [ 1386081.101269942475483, 5860033.01989212166518 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_39_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_39", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_718_generated", "manhole_dn": "manhole_724_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386079.86695942771621, 5859885.500408614054322 ], [ 1386051.415038994979113, 5859913.714703594334424 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_39_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_39", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_724_generated", "manhole_dn": "manhole_725_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386051.415038994979113, 5859913.714703594334424 ], [ 1386056.753747603856027, 5859949.43277302198112 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_39_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_39", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_725_generated", "manhole_dn": "manhole_726_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386056.753747603856027, 5859949.43277302198112 ], [ 1386070.153564189793542, 5859990.873222404159606 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_39_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_39", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 756.5, "invlev_up": 763.79998779296875, "invlev_dn": 754.0, "manhole_up": "manhole_726_generated", "manhole_dn": "manhole_723_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386070.153564189793542, 5859990.873222404159606 ], [ 1386081.101269942475483, 5860033.01989212166518 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.5, "elevtn_dn": 756.5, "invlev_up": 754.0, "invlev_dn": 754.0, "manhole_up": "manhole_723_generated", "manhole_dn": "manhole_727_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386081.101269942475483, 5860033.01989212166518 ], [ 1386095.159510504920036, 5860079.476792480796576 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.5, "elevtn_dn": 720.29998779296875, "invlev_up": 754.0, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_727_generated", "manhole_dn": "manhole_728_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386095.159510504920036, 5860079.476792480796576 ], [ 1386119.249574675457552, 5860122.285581497475505 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_728_generated", "manhole_dn": "manhole_729_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386119.249574675457552, 5860122.285581497475505 ], [ 1386143.813145637512207, 5860164.822058788500726 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 732.5, "invlev_up": 717.79998779296875, "invlev_dn": 730.0, "manhole_up": "manhole_729_generated", "manhole_dn": "manhole_730_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386143.813145637512207, 5860164.822058788500726 ], [ 1386168.698389830067754, 5860207.173543182201684 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.5, "elevtn_dn": 732.5, "invlev_up": 730.0, "invlev_dn": 730.0, "manhole_up": "manhole_730_generated", "manhole_dn": "manhole_731_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386168.698389830067754, 5860207.173543182201684 ], [ 1386190.960878706537187, 5860250.914158629253507 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.5, "elevtn_dn": 720.29998779296875, "invlev_up": 730.0, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_731_generated", "manhole_dn": "manhole_732_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386190.960878706537187, 5860250.914158629253507 ], [ 1386212.013376480899751, 5860295.295640649273992 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 729.10003662109375, "invlev_up": 717.79998779296875, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_732_generated", "manhole_dn": "manhole_733_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386212.013376480899751, 5860295.295640649273992 ], [ 1386233.065874255495146, 5860339.677122670225799 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 729.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_733_generated", "manhole_dn": "manhole_734_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386233.065874255495146, 5860339.677122670225799 ], [ 1386254.118372030090541, 5860384.058604690246284 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 729.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_734_generated", "manhole_dn": "manhole_735_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386254.118372030090541, 5860384.058604690246284 ], [ 1386270.265550139825791, 5860430.368606903590262 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 746.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 743.60003662109375, "manhole_up": "manhole_735_generated", "manhole_dn": "manhole_736_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386270.265550139825791, 5860430.368606903590262 ], [ 1386284.690116602927446, 5860477.310510716401041 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 746.10003662109375, "elevtn_dn": 746.10003662109375, "invlev_up": 743.60003662109375, "invlev_dn": 743.60003662109375, "manhole_up": "manhole_736_generated", "manhole_dn": "manhole_737_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386284.690116602927446, 5860477.310510716401041 ], [ 1386295.943752367515117, 5860525.125563691370189 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 746.10003662109375, "elevtn_dn": 720.29998779296875, "invlev_up": 743.60003662109375, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_737_generated", "manhole_dn": "manhole_738_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386295.943752367515117, 5860525.125563691370189 ], [ 1386307.197388132335618, 5860572.940616665408015 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_738_generated", "manhole_dn": "manhole_739_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386307.197388132335618, 5860572.940616665408015 ], [ 1386318.451023896923289, 5860620.755669640377164 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_739_generated", "manhole_dn": "manhole_740_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386318.451023896923289, 5860620.755669640377164 ], [ 1386329.704659661510959, 5860668.57072261441499 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 737.60003662109375, "invlev_up": 717.79998779296875, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_740_generated", "manhole_dn": "manhole_741_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386329.704659661510959, 5860668.57072261441499 ], [ 1386340.95829542633146, 5860716.385775589384139 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 737.60003662109375, "invlev_up": 735.10003662109375, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_741_generated", "manhole_dn": "manhole_742_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386340.95829542633146, 5860716.385775589384139 ], [ 1386352.211931190919131, 5860764.200828563421965 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 737.60003662109375, "invlev_up": 735.10003662109375, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_742_generated", "manhole_dn": "manhole_743_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386352.211931190919131, 5860764.200828563421965 ], [ 1386365.771370212780312, 5860811.365820310078561 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 744.5, "invlev_up": 735.10003662109375, "invlev_dn": 742.0, "manhole_up": "manhole_743_generated", "manhole_dn": "manhole_744_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386365.771370212780312, 5860811.365820310078561 ], [ 1386381.150273493025452, 5860858.017861452884972 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 744.5, "elevtn_dn": 724.29998779296875, "invlev_up": 742.0, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_744_generated", "manhole_dn": "manhole_745_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386381.150273493025452, 5860858.017861452884972 ], [ 1386398.399082327727228, 5860903.951519219204783 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_745_generated", "manhole_dn": "manhole_746_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386398.399082327727228, 5860903.951519219204783 ], [ 1386418.211523674428463, 5860948.90027645137161 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_746_generated", "manhole_dn": "manhole_747_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386418.211523674428463, 5860948.90027645137161 ], [ 1386441.67837643600069, 5860992.033180211670697 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_747_generated", "manhole_dn": "manhole_748_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386441.67837643600069, 5860992.033180211670697 ], [ 1386465.536530936835334, 5861034.971648660488427 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.9000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 722.4000244140625, "manhole_up": "manhole_748_generated", "manhole_dn": "manhole_749_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386465.536530936835334, 5861034.971648660488427 ], [ 1386489.394685437437147, 5861077.910117109306157 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.9000244140625, "elevtn_dn": 724.29998779296875, "invlev_up": 722.4000244140625, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_749_generated", "manhole_dn": "manhole_750_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386489.394685437437147, 5861077.910117109306157 ], [ 1386513.252839938271791, 5861120.848585557192564 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_750_generated", "manhole_dn": "manhole_751_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386513.252839938271791, 5861120.848585557192564 ], [ 1386537.110994438873604, 5861163.787054006010294 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_751_generated", "manhole_dn": "manhole_752_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386537.110994438873604, 5861163.787054006010294 ], [ 1386560.969148939708248, 5861206.725522454828024 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_752_generated", "manhole_dn": "manhole_753_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386560.969148939708248, 5861206.725522454828024 ], [ 1386584.827303440310061, 5861249.663990902714431 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_753_generated", "manhole_dn": "manhole_754_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386584.827303440310061, 5861249.663990902714431 ], [ 1386607.696082097478211, 5861293.105181481689215 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_754_generated", "manhole_dn": "manhole_755_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386607.696082097478211, 5861293.105181481689215 ], [ 1386626.999141034670174, 5861338.164890616200864 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 732.4000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_755_generated", "manhole_dn": "manhole_756_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386626.999141034670174, 5861338.164890616200864 ], [ 1386632.635544582502916, 5861386.242180755361915 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_756_generated", "manhole_dn": "manhole_757_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386632.635544582502916, 5861386.242180755361915 ], [ 1386628.332881111185998, 5861435.174896763637662 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_757_generated", "manhole_dn": "manhole_758_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386628.332881111185998, 5861435.174896763637662 ], [ 1386624.030217639869079, 5861484.107612771913409 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 758.79998779296875, "invlev_up": 729.9000244140625, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_758_generated", "manhole_dn": "manhole_759_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386624.030217639869079, 5861484.107612771913409 ], [ 1386619.72755416855216, 5861533.040328779257834 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_759_generated", "manhole_dn": "manhole_760_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386619.72755416855216, 5861533.040328779257834 ], [ 1386620.396809899713844, 5861581.843449912965298 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_760_generated", "manhole_dn": "manhole_761_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386620.396809899713844, 5861581.843449912965298 ], [ 1386627.242796876933426, 5861630.485572309233248 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 777.9000244140625, "invlev_up": 756.29998779296875, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_761_generated", "manhole_dn": "manhole_762_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386627.242796876933426, 5861630.485572309233248 ], [ 1386633.497009602142498, 5861679.177458625286818 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 777.9000244140625, "invlev_up": 775.4000244140625, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_762_generated", "manhole_dn": "manhole_763_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386633.497009602142498, 5861679.177458625286818 ], [ 1386633.587326586712152, 5861728.232037586160004 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 777.9000244140625, "invlev_up": 775.4000244140625, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_763_generated", "manhole_dn": "manhole_764_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386633.587326586712152, 5861728.232037586160004 ], [ 1386628.569951781770214, 5861777.096641942858696 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 787.0, "invlev_up": 775.4000244140625, "invlev_dn": 784.5, "manhole_up": "manhole_764_generated", "manhole_dn": "manhole_765_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386628.569951781770214, 5861777.096641942858696 ], [ 1386623.552576976828277, 5861825.961246299557388 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.0, "elevtn_dn": 787.0, "invlev_up": 784.5, "invlev_dn": 784.5, "manhole_up": "manhole_765_generated", "manhole_dn": "manhole_766_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386623.552576976828277, 5861825.961246299557388 ], [ 1386622.452884682221338, 5861875.377415779046714 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.0, "elevtn_dn": 768.0, "invlev_up": 784.5, "invlev_dn": 765.5, "manhole_up": "manhole_766_generated", "manhole_dn": "manhole_767_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386622.452884682221338, 5861875.377415779046714 ], [ 1386630.050831846194342, 5861924.208797036670148 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_767_generated", "manhole_dn": "manhole_768_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386630.050831846194342, 5861924.208797036670148 ], [ 1386645.112437101313844, 5861971.295391816645861 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_768_generated", "manhole_dn": "manhole_769_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386645.112437101313844, 5861971.295391816645861 ], [ 1386663.826805545249954, 5862017.116109635680914 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 729.0, "invlev_up": 765.5, "invlev_dn": 726.5, "manhole_up": "manhole_769_generated", "manhole_dn": "manhole_770_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386663.826805545249954, 5862017.116109635680914 ], [ 1386682.541173989186063, 5862062.93682745564729 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 729.0, "invlev_up": 726.5, "invlev_dn": 726.5, "manhole_up": "manhole_770_generated", "manhole_dn": "manhole_771_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386682.541173989186063, 5862062.93682745564729 ], [ 1386700.357504795538262, 5862109.113540357910097 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 729.0, "invlev_up": 726.5, "invlev_dn": 726.5, "manhole_up": "manhole_771_generated", "manhole_dn": "manhole_772_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386700.357504795538262, 5862109.113540357910097 ], [ 1386718.120609947945923, 5862155.311352676711977 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 724.29998779296875, "invlev_up": 726.5, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_772_generated", "manhole_dn": "manhole_773_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386718.120609947945923, 5862155.311352676711977 ], [ 1386735.883715100120753, 5862201.509164996445179 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_773_generated", "manhole_dn": "manhole_774_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386735.883715100120753, 5862201.509164996445179 ], [ 1386757.522535112220794, 5862245.993861058726907 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_774_generated", "manhole_dn": "manhole_775_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386757.522535112220794, 5862245.993861058726907 ], [ 1386779.73098383564502, 5862290.226773838512599 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_775_generated", "manhole_dn": "manhole_776_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386779.73098383564502, 5862290.226773838512599 ], [ 1386802.545179207576439, 5862334.095372994430363 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_776_generated", "manhole_dn": "manhole_777_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386802.545179207576439, 5862334.095372994430363 ], [ 1386831.207993831252679, 5862374.446442689746618 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 737.70001220703125, "invlev_up": 721.79998779296875, "invlev_dn": 735.20001220703125, "manhole_up": "manhole_777_generated", "manhole_dn": "manhole_778_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386831.207993831252679, 5862374.446442689746618 ], [ 1386859.988485741894692, 5862414.708453865721822 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.70001220703125, "elevtn_dn": 737.70001220703125, "invlev_up": 735.20001220703125, "invlev_dn": 735.20001220703125, "manhole_up": "manhole_778_generated", "manhole_dn": "manhole_779_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386859.988485741894692, 5862414.708453865721822 ], [ 1386891.035651177866384, 5862453.255039785988629 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.70001220703125, "elevtn_dn": 743.9000244140625, "invlev_up": 735.20001220703125, "invlev_dn": 741.4000244140625, "manhole_up": "manhole_779_generated", "manhole_dn": "manhole_780_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386891.035651177866384, 5862453.255039785988629 ], [ 1386922.082816614070907, 5862491.801625707186759 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 743.9000244140625, "elevtn_dn": 756.0, "invlev_up": 741.4000244140625, "invlev_dn": 753.5, "manhole_up": "manhole_780_generated", "manhole_dn": "manhole_781_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386922.082816614070907, 5862491.801625707186759 ], [ 1386953.12998205027543, 5862530.348211627453566 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.0, "elevtn_dn": 756.0, "invlev_up": 753.5, "invlev_dn": 753.5, "manhole_up": "manhole_781_generated", "manhole_dn": "manhole_782_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386953.12998205027543, 5862530.348211627453566 ], [ 1386984.177147486479953, 5862568.894797547720373 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.0, "elevtn_dn": 761.4000244140625, "invlev_up": 753.5, "invlev_dn": 758.9000244140625, "manhole_up": "manhole_782_generated", "manhole_dn": "manhole_783_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386984.177147486479953, 5862568.894797547720373 ], [ 1387010.83190148579888, 5862610.297833287157118 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.4000244140625, "elevtn_dn": 761.4000244140625, "invlev_up": 758.9000244140625, "invlev_dn": 758.9000244140625, "manhole_up": "manhole_783_generated", "manhole_dn": "manhole_784_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387010.83190148579888, 5862610.297833287157118 ], [ 1387033.474099110113457, 5862654.310293504968286 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.4000244140625, "elevtn_dn": 770.5, "invlev_up": 758.9000244140625, "invlev_dn": 768.0, "manhole_up": "manhole_784_generated", "manhole_dn": "manhole_785_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387033.474099110113457, 5862654.310293504968286 ], [ 1387056.116296734428033, 5862698.322753723710775 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.5, "elevtn_dn": 765.29998779296875, "invlev_up": 768.0, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_785_generated", "manhole_dn": "manhole_786_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387056.116296734428033, 5862698.322753723710775 ], [ 1387078.75849435874261, 5862742.335213942453265 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 765.29998779296875, "invlev_up": 762.79998779296875, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_786_generated", "manhole_dn": "manhole_787_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387078.75849435874261, 5862742.335213942453265 ], [ 1387101.400691983057186, 5862786.347674161195755 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 765.29998779296875, "invlev_up": 762.79998779296875, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_787_generated", "manhole_dn": "manhole_788_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387101.400691983057186, 5862786.347674161195755 ], [ 1387124.783531384309754, 5862829.966971693560481 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 764.20001220703125, "invlev_up": 762.79998779296875, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_788_generated", "manhole_dn": "manhole_789_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387124.783531384309754, 5862829.966971693560481 ], [ 1387148.551342260092497, 5862873.381910757161677 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 764.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_789_generated", "manhole_dn": "manhole_790_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387148.551342260092497, 5862873.381910757161677 ], [ 1387176.029596295906231, 5862914.516764627769589 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 764.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_790_generated", "manhole_dn": "manhole_791_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387176.029596295906231, 5862914.516764627769589 ], [ 1387204.050833505578339, 5862955.315435893833637 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 769.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 766.70001220703125, "manhole_up": "manhole_791_generated", "manhole_dn": "manhole_792_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387204.050833505578339, 5862955.315435893833637 ], [ 1387233.152246462181211, 5862995.351338926702738 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.20001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 766.70001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_792_generated", "manhole_dn": "manhole_793_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387233.152246462181211, 5862995.351338926702738 ], [ 1387262.253659419016913, 5863035.387241959571838 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 770.20001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_793_generated", "manhole_dn": "manhole_794_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387262.253659419016913, 5863035.387241959571838 ], [ 1387289.177211825968698, 5863076.714860137552023 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 770.20001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_794_generated", "manhole_dn": "manhole_795_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387289.177211825968698, 5863076.714860137552023 ], [ 1387304.666786204557866, 5863123.392671256326139 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 762.0, "invlev_up": 770.20001220703125, "invlev_dn": 759.5, "manhole_up": "manhole_795_generated", "manhole_dn": "manhole_796_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387304.666786204557866, 5863123.392671256326139 ], [ 1387314.520281337434426, 5863171.895173518918455 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 777.10003662109375, "invlev_up": 759.5, "invlev_dn": 774.60003662109375, "manhole_up": "manhole_796_generated", "manhole_dn": "manhole_797_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387314.520281337434426, 5863171.895173518918455 ], [ 1387324.142220750683919, 5863220.446013364940882 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.10003662109375, "elevtn_dn": 780.4000244140625, "invlev_up": 774.60003662109375, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_797_generated", "manhole_dn": "manhole_798_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387324.142220750683919, 5863220.446013364940882 ], [ 1387333.764160163700581, 5863268.996853210031986 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 780.4000244140625, "invlev_up": 777.9000244140625, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_798_generated", "manhole_dn": "manhole_799_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387333.764160163700581, 5863268.996853210031986 ], [ 1387343.386099576717243, 5863317.547693055123091 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 780.4000244140625, "invlev_up": 777.9000244140625, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_799_generated", "manhole_dn": "manhole_800_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387343.386099576717243, 5863317.547693055123091 ], [ 1387353.008038989733905, 5863366.098532900214195 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 762.0, "invlev_up": 777.9000244140625, "invlev_dn": 759.5, "manhole_up": "manhole_800_generated", "manhole_dn": "manhole_801_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387353.008038989733905, 5863366.098532900214195 ], [ 1387364.066297837067395, 5863414.311534740030766 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_801_generated", "manhole_dn": "manhole_802_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387364.066297837067395, 5863414.311534740030766 ], [ 1387381.839409928303212, 5863460.427046488039196 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_802_generated", "manhole_dn": "manhole_803_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387381.839409928303212, 5863460.427046488039196 ], [ 1387403.429578960640356, 5863504.96100580971688 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_803_generated", "manhole_dn": "manhole_804_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387403.429578960640356, 5863504.96100580971688 ], [ 1387425.140452897874638, 5863549.440256260335445 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_804_generated", "manhole_dn": "manhole_805_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387425.140452897874638, 5863549.440256260335445 ], [ 1387446.851326835108921, 5863593.91950671095401 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_805_generated", "manhole_dn": "manhole_806_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387446.851326835108921, 5863593.91950671095401 ], [ 1387467.528695637593046, 5863638.888379830867052 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 774.5, "invlev_up": 759.5, "invlev_dn": 772.0, "manhole_up": "manhole_806_generated", "manhole_dn": "manhole_807_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387467.528695637593046, 5863638.888379830867052 ], [ 1387488.196078018052503, 5863683.861984014511108 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.5, "elevtn_dn": 762.0, "invlev_up": 772.0, "invlev_dn": 759.5, "manhole_up": "manhole_807_generated", "manhole_dn": "manhole_808_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387488.196078018052503, 5863683.861984014511108 ], [ 1387508.863468252588063, 5863728.835584589280188 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_808_generated", "manhole_dn": "manhole_809_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387508.863468252588063, 5863728.835584589280188 ], [ 1387529.53130904212594, 5863773.808978110551834 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_809_generated", "manhole_dn": "manhole_810_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387529.53130904212594, 5863773.808978110551834 ], [ 1387553.168002701364458, 5863817.17347530182451 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_810_generated", "manhole_dn": "manhole_811_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387553.168002701364458, 5863817.17347530182451 ], [ 1387579.562712850514799, 5863859.043333718553185 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 777.0, "invlev_up": 759.5, "invlev_dn": 774.5, "manhole_up": "manhole_811_generated", "manhole_dn": "manhole_812_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387579.562712850514799, 5863859.043333718553185 ], [ 1387605.957422999665141, 5863900.913192136213183 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.0, "elevtn_dn": 762.0, "invlev_up": 774.5, "invlev_dn": 759.5, "manhole_up": "manhole_812_generated", "manhole_dn": "manhole_813_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387605.957422999665141, 5863900.913192136213183 ], [ 1387632.352133149048313, 5863942.783050553873181 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E48", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_813_generated", "manhole_dn": "manhole_814_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387632.352133149048313, 5863942.783050553873181 ], [ 1387658.746843298198655, 5863984.652908970601857 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E49", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_814_generated", "manhole_dn": "manhole_815_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387658.746843298198655, 5863984.652908970601857 ], [ 1387685.893106181640178, 5864026.029537551105022 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E50", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_815_generated", "manhole_dn": "manhole_816_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387685.893106181640178, 5864026.029537551105022 ], [ 1387711.231136992340907, 5864068.42725711222738 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E51", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_816_generated", "manhole_dn": "manhole_817_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387711.231136992340907, 5864068.42725711222738 ], [ 1387731.020947323646396, 5864113.414904261007905 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E52", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_817_generated", "manhole_dn": "manhole_818_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387731.020947323646396, 5864113.414904261007905 ], [ 1387737.361907477490604, 5864162.342261835932732 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E53", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_818_generated", "manhole_dn": "manhole_819_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387737.361907477490604, 5864162.342261835932732 ], [ 1387732.727565656881779, 5864211.475179814733565 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E54", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_819_generated", "manhole_dn": "manhole_820_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387732.727565656881779, 5864211.475179814733565 ], [ 1387717.67884943424724, 5864258.627082298509777 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E55", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_820_generated", "manhole_dn": "manhole_821_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387717.67884943424724, 5864258.627082298509777 ], [ 1387709.67210421175696, 5864307.23127611912787 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E56", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 768.0, "invlev_up": 759.5, "invlev_dn": 765.5, "manhole_up": "manhole_821_generated", "manhole_dn": "manhole_822_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387709.67210421175696, 5864307.23127611912787 ], [ 1387707.11288084089756, 5864356.66017600055784 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E57", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_822_generated", "manhole_dn": "manhole_823_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387707.11288084089756, 5864356.66017600055784 ], [ 1387709.591797993984073, 5864406.012949175201356 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E58", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_823_generated", "manhole_dn": "manhole_824_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387709.591797993984073, 5864406.012949175201356 ], [ 1387713.643261310644448, 5864455.341961052268744 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E59", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 777.20001220703125, "invlev_up": 765.5, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_824_generated", "manhole_dn": "manhole_825_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387713.643261310644448, 5864455.341961052268744 ], [ 1387715.877521668095142, 5864504.642317942343652 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E60", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 774.70001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_825_generated", "manhole_dn": "manhole_826_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387715.877521668095142, 5864504.642317942343652 ], [ 1387708.68023270717822, 5864553.426558391191065 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E61", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 774.70001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_826_generated", "manhole_dn": "manhole_827_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387708.68023270717822, 5864553.426558391191065 ], [ 1387690.790250770282, 5864599.575386263430119 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E62", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 810.60003662109375, "invlev_up": 774.70001220703125, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_827_generated", "manhole_dn": "manhole_828_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387690.790250770282, 5864599.575386263430119 ], [ 1387672.900268833618611, 5864645.724214136600494 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E63", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 810.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_828_generated", "manhole_dn": "manhole_829_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387672.900268833618611, 5864645.724214136600494 ], [ 1387659.931900478899479, 5864692.98388583958149 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E64", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 810.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_829_generated", "manhole_dn": "manhole_830_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387659.931900478899479, 5864692.98388583958149 ], [ 1387659.223570322152227, 5864742.029465307481587 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E65", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_830_generated", "manhole_dn": "manhole_831_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387659.223570322152227, 5864742.029465307481587 ], [ 1387675.926896508783102, 5864788.273513910360634 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E66", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 774.10003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 771.60003662109375, "manhole_up": "manhole_831_generated", "manhole_dn": "manhole_832_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387675.926896508783102, 5864788.273513910360634 ], [ 1387702.296291569946334, 5864830.159320239908993 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E67", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.10003662109375, "elevtn_dn": 774.10003662109375, "invlev_up": 771.60003662109375, "invlev_dn": 771.60003662109375, "manhole_up": "manhole_832_generated", "manhole_dn": "manhole_833_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387702.296291569946334, 5864830.159320239908993 ], [ 1387728.665686630876735, 5864872.045126569457352 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E68", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.10003662109375, "elevtn_dn": 782.5, "invlev_up": 771.60003662109375, "invlev_dn": 780.0, "manhole_up": "manhole_833_generated", "manhole_dn": "manhole_834_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387728.665686630876735, 5864872.045126569457352 ], [ 1387751.608185108983889, 5864915.528788692317903 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E69", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 782.5, "invlev_up": 780.0, "invlev_dn": 780.0, "manhole_up": "manhole_834_generated", "manhole_dn": "manhole_835_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387751.608185108983889, 5864915.528788692317903 ], [ 1387766.741664502769709, 5864962.653554677963257 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E70", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 782.5, "invlev_up": 780.0, "invlev_dn": 780.0, "manhole_up": "manhole_835_generated", "manhole_dn": "manhole_836_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387766.741664502769709, 5864962.653554677963257 ], [ 1387778.99191950308159, 5865010.246724016033113 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E71", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 820.20001220703125, "invlev_up": 780.0, "invlev_dn": 817.70001220703125, "manhole_up": "manhole_836_generated", "manhole_dn": "manhole_837_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387778.99191950308159, 5865010.246724016033113 ], [ 1387779.554608268430457, 5865059.738633952103555 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E72", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.20001220703125, "elevtn_dn": 820.20001220703125, "invlev_up": 817.70001220703125, "invlev_dn": 817.70001220703125, "manhole_up": "manhole_837_generated", "manhole_dn": "manhole_838_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387779.554608268430457, 5865059.738633952103555 ], [ 1387780.117297033779323, 5865109.230543887242675 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E73", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.20001220703125, "elevtn_dn": 834.60003662109375, "invlev_up": 817.70001220703125, "invlev_dn": 832.10003662109375, "manhole_up": "manhole_838_generated", "manhole_dn": "manhole_839_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387780.117297033779323, 5865109.230543887242675 ], [ 1387782.917817069217563, 5865158.566991245374084 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E74", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 834.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 832.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_839_generated", "manhole_dn": "manhole_840_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387782.917817069217563, 5865158.566991245374084 ], [ 1387789.203931836877018, 5865207.661293652839959 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E75", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_840_generated", "manhole_dn": "manhole_841_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387789.203931836877018, 5865207.661293652839959 ], [ 1387795.490046604769304, 5865256.755596060305834 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E76", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_841_generated", "manhole_dn": "manhole_842_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387795.490046604769304, 5865256.755596060305834 ], [ 1387804.549934879876673, 5865305.332479531876743 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E77", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 809.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_842_generated", "manhole_dn": "manhole_843_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387804.549934879876673, 5865305.332479531876743 ], [ 1387816.386747075244784, 5865353.391356389038265 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E78", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 809.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_843_generated", "manhole_dn": "manhole_844_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387816.386747075244784, 5865353.391356389038265 ], [ 1387828.223559270845726, 5865401.450233246199787 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E79", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 802.5, "invlev_up": 809.10003662109375, "invlev_dn": 800.0, "manhole_up": "manhole_844_generated", "manhole_dn": "manhole_845_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387828.223559270845726, 5865401.450233246199787 ], [ 1387842.96627543354407, 5865448.679594250395894 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E80", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 802.5, "invlev_up": 800.0, "invlev_dn": 800.0, "manhole_up": "manhole_845_generated", "manhole_dn": "manhole_846_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387842.96627543354407, 5865448.679594250395894 ], [ 1387858.283513206522912, 5865495.744953005574644 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E81", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 802.5, "invlev_up": 800.0, "invlev_dn": 800.0, "manhole_up": "manhole_846_generated", "manhole_dn": "manhole_847_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387858.283513206522912, 5865495.744953005574644 ], [ 1387872.788357679266483, 5865543.026506381109357 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E82", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 778.20001220703125, "invlev_up": 800.0, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_847_generated", "manhole_dn": "manhole_848_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387872.788357679266483, 5865543.026506381109357 ], [ 1387882.890574953285977, 5865591.479689701460302 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E83", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_848_generated", "manhole_dn": "manhole_849_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387882.890574953285977, 5865591.479689701460302 ], [ 1387892.992792227305472, 5865639.932873022742569 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E84", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_849_generated", "manhole_dn": "manhole_850_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387892.992792227305472, 5865639.932873022742569 ], [ 1387903.095009501324967, 5865688.386056343093514 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E85", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_850_generated", "manhole_dn": "manhole_851_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387903.095009501324967, 5865688.386056343093514 ], [ 1387913.197226775344461, 5865736.839239663444459 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 830.9000244140625, "invlev_up": 828.4000244140625, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_852_generated", "manhole_dn": "manhole_853_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387767.438602478476241, 5866395.894650792703032 ], [ 1387758.181959156645462, 5866444.388786932453513 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 830.9000244140625, "invlev_up": 828.4000244140625, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_853_generated", "manhole_dn": "manhole_854_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387758.181959156645462, 5866444.388786932453513 ], [ 1387748.925315835047513, 5866492.882923071272671 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 816.5, "invlev_up": 828.4000244140625, "invlev_dn": 814.0, "manhole_up": "manhole_854_generated", "manhole_dn": "manhole_855_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387748.925315835047513, 5866492.882923071272671 ], [ 1387739.668672513216734, 5866541.377059211023152 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.5, "elevtn_dn": 816.5, "invlev_up": 814.0, "invlev_dn": 814.0, "manhole_up": "manhole_855_generated", "manhole_dn": "manhole_856_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387739.668672513216734, 5866541.377059211023152 ], [ 1387730.412029191618785, 5866589.87119534984231 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.5, "elevtn_dn": 816.10003662109375, "invlev_up": 814.0, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_856_generated", "manhole_dn": "manhole_857_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387730.412029191618785, 5866589.87119534984231 ], [ 1387721.155385869788006, 5866638.365331489592791 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 816.10003662109375, "invlev_up": 813.60003662109375, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_857_generated", "manhole_dn": "manhole_858_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387721.155385869788006, 5866638.365331489592791 ], [ 1387711.868742506252602, 5866686.853722332976758 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 816.10003662109375, "invlev_up": 813.60003662109375, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_858_generated", "manhole_dn": "manhole_859_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387711.868742506252602, 5866686.853722332976758 ], [ 1387702.553355348296463, 5866735.336608462966979 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 802.4000244140625, "invlev_up": 813.60003662109375, "invlev_dn": 799.9000244140625, "manhole_up": "manhole_859_generated", "manhole_dn": "manhole_860_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387702.553355348296463, 5866735.336608462966979 ], [ 1387692.161796326050535, 5866783.420620376244187 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_43_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_43", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_43", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_861_generated", "manhole_dn": "manhole_862_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387809.534624515566975, 5866309.639251782558858 ], [ 1387788.486613497138023, 5866352.766951287165284 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_43_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_43", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_43", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 830.9000244140625, "invlev_up": 803.70001220703125, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_862_generated", "manhole_dn": "manhole_852_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387788.486613497138023, 5866352.766951287165284 ], [ 1387767.438602478476241, 5866395.894650792703032 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 840.10003662109375, "invlev_up": 828.4000244140625, "invlev_dn": 837.60003662109375, "manhole_up": "manhole_852_generated", "manhole_dn": "manhole_863_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387767.438602478476241, 5866395.894650792703032 ], [ 1387774.73306847945787, 5866351.644692087545991 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 840.10003662109375, "elevtn_dn": 806.20001220703125, "invlev_up": 837.60003662109375, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_863_generated", "manhole_dn": "manhole_864_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387774.73306847945787, 5866351.644692087545991 ], [ 1387787.219046234386042, 5866308.756401930935681 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_864_generated", "manhole_dn": "manhole_865_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387787.219046234386042, 5866308.756401930935681 ], [ 1387802.581935805035755, 5866266.622689731419086 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_865_generated", "manhole_dn": "manhole_866_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387802.581935805035755, 5866266.622689731419086 ], [ 1387818.989883717847988, 5866224.886323318816721 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_866_generated", "manhole_dn": "manhole_867_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387818.989883717847988, 5866224.886323318816721 ], [ 1387838.767447788733989, 5866184.784887914545834 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_867_generated", "manhole_dn": "manhole_868_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387838.767447788733989, 5866184.784887914545834 ], [ 1387862.375427621416748, 5866146.679679537191987 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 803.9000244140625, "invlev_up": 825.20001220703125, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_868_generated", "manhole_dn": "manhole_869_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387862.375427621416748, 5866146.679679537191987 ], [ 1387890.316308293025941, 5866111.904927220195532 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_869_generated", "manhole_dn": "manhole_870_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387890.316308293025941, 5866111.904927220195532 ], [ 1387932.086585889104754, 5866099.149365295656025 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_45_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_45", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_871_generated", "manhole_dn": "manhole_872_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387931.614702571649104, 5866170.542120457626879 ], [ 1387899.497387683717534, 5866203.806988564319909 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_45_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_45", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 806.20001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_872_generated", "manhole_dn": "manhole_873_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387899.497387683717534, 5866203.806988564319909 ], [ 1387869.509799961000681, 5866239.084409636445343 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_45_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_45", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_873_generated", "manhole_dn": "manhole_874_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387869.509799961000681, 5866239.084409636445343 ], [ 1387839.522212238283828, 5866274.361830709502101 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_45_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_45", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_874_generated", "manhole_dn": "manhole_861_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387839.522212238283828, 5866274.361830709502101 ], [ 1387809.534624515566975, 5866309.639251782558858 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_46_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_870_generated", "manhole_dn": "manhole_875_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387932.086585889104754, 5866099.149365295656025 ], [ 1387908.367353544337675, 5866141.903963415883482 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_46_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_875_generated", "manhole_dn": "manhole_876_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387908.367353544337675, 5866141.903963415883482 ], [ 1387876.955022902460769, 5866179.987773489207029 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_46_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 827.70001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_876_generated", "manhole_dn": "manhole_877_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387876.955022902460769, 5866179.987773489207029 ], [ 1387847.458594153402373, 5866219.470102892257273 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_46_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_877_generated", "manhole_dn": "manhole_878_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387847.458594153402373, 5866219.470102892257273 ], [ 1387823.639855962945148, 5866262.662997540086508 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_46_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_878_generated", "manhole_dn": "manhole_861_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387823.639855962945148, 5866262.662997540086508 ], [ 1387809.534624515566975, 5866309.639251782558858 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_47_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_879_generated", "manhole_dn": "manhole_880_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.443674022099003, 5865845.093254727311432 ], [ 1387943.318034203490242, 5865887.628139751963317 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_47_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_880_generated", "manhole_dn": "manhole_881_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387943.318034203490242, 5865887.628139751963317 ], [ 1387946.009428307646886, 5865930.175072746351361 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_47_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 816.70001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_881_generated", "manhole_dn": "manhole_882_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387946.009428307646886, 5865930.175072746351361 ], [ 1387948.700822412036359, 5865972.722005739808083 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_47_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_882_generated", "manhole_dn": "manhole_883_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387948.700822412036359, 5865972.722005739808083 ], [ 1387944.872250664513558, 5866015.105105520226061 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_47_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_883_generated", "manhole_dn": "manhole_884_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387944.872250664513558, 5866015.105105520226061 ], [ 1387940.047370131826028, 5866057.463170127011836 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_47_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 803.9000244140625, "invlev_up": 814.20001220703125, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_884_generated", "manhole_dn": "manhole_870_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.047370131826028, 5866057.463170127011836 ], [ 1387932.086585889104754, 5866099.149365295656025 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_48_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_48", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_48", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 786.29998779296875, "invlev_up": 801.4000244140625, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_870_generated", "manhole_dn": "manhole_885_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387932.086585889104754, 5866099.149365295656025 ], [ 1387975.279995472636074, 5866107.425722245126963 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E125", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.5, "elevtn_dn": 910.4000244140625, "invlev_up": 907.0, "invlev_dn": 907.9000244140625, "manhole_up": "manhole_886_generated", "manhole_dn": "manhole_887_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392926.966794768813998, 5866808.501405037939548 ], [ 1392879.417931769276038, 5866793.491589142940938 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E126", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 910.4000244140625, "elevtn_dn": 910.4000244140625, "invlev_up": 907.9000244140625, "invlev_dn": 907.9000244140625, "manhole_up": "manhole_887_generated", "manhole_dn": "manhole_888_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392879.417931769276038, 5866793.491589142940938 ], [ 1392831.869068769738078, 5866778.481773247942328 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E127", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 910.4000244140625, "elevtn_dn": 865.0, "invlev_up": 907.9000244140625, "invlev_dn": 862.5, "manhole_up": "manhole_888_generated", "manhole_dn": "manhole_889_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392831.869068769738078, 5866778.481773247942328 ], [ 1392784.320205770200118, 5866763.471957352943718 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E128", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 865.0, "elevtn_dn": 865.0, "invlev_up": 862.5, "invlev_dn": 862.5, "manhole_up": "manhole_889_generated", "manhole_dn": "manhole_890_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392784.320205770200118, 5866763.471957352943718 ], [ 1392736.771342770429328, 5866748.462141457945108 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E129", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 865.0, "elevtn_dn": 878.4000244140625, "invlev_up": 862.5, "invlev_dn": 875.9000244140625, "manhole_up": "manhole_890_generated", "manhole_dn": "manhole_891_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392736.771342770429328, 5866748.462141457945108 ], [ 1392689.222479770891368, 5866733.452325562946498 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E130", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 878.4000244140625, "elevtn_dn": 878.4000244140625, "invlev_up": 875.9000244140625, "invlev_dn": 875.9000244140625, "manhole_up": "manhole_891_generated", "manhole_dn": "manhole_892_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392689.222479770891368, 5866733.452325562946498 ], [ 1392641.673616771353409, 5866718.442509667947888 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E131", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 878.4000244140625, "elevtn_dn": 904.9000244140625, "invlev_up": 875.9000244140625, "invlev_dn": 902.4000244140625, "manhole_up": "manhole_892_generated", "manhole_dn": "manhole_893_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392641.673616771353409, 5866718.442509667947888 ], [ 1392594.124753771815449, 5866703.432693773880601 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E132", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 904.9000244140625, "elevtn_dn": 904.9000244140625, "invlev_up": 902.4000244140625, "invlev_dn": 902.4000244140625, "manhole_up": "manhole_893_generated", "manhole_dn": "manhole_894_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392594.124753771815449, 5866703.432693773880601 ], [ 1392546.575890772277489, 5866688.422877878881991 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E133", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 904.9000244140625, "elevtn_dn": 931.5, "invlev_up": 902.4000244140625, "invlev_dn": 929.0, "manhole_up": "manhole_894_generated", "manhole_dn": "manhole_895_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392546.575890772277489, 5866688.422877878881991 ], [ 1392499.02702777273953, 5866673.413061983883381 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E134", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 931.5, "elevtn_dn": 931.5, "invlev_up": 929.0, "invlev_dn": 929.0, "manhole_up": "manhole_895_generated", "manhole_dn": "manhole_896_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392499.02702777273953, 5866673.413061983883381 ], [ 1392451.47816477320157, 5866658.403246088884771 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E135", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 931.5, "elevtn_dn": 926.29998779296875, "invlev_up": 929.0, "invlev_dn": 923.79998779296875, "manhole_up": "manhole_896_generated", "manhole_dn": "manhole_897_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392451.47816477320157, 5866658.403246088884771 ], [ 1392403.92930177366361, 5866643.393430193886161 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E136", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 926.29998779296875, "elevtn_dn": 849.79998779296875, "invlev_up": 923.79998779296875, "invlev_dn": 847.29998779296875, "manhole_up": "manhole_897_generated", "manhole_dn": "manhole_898_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392403.92930177366361, 5866643.393430193886161 ], [ 1392356.380438774125651, 5866628.383614298887551 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E137", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 849.79998779296875, "elevtn_dn": 875.20001220703125, "invlev_up": 847.29998779296875, "invlev_dn": 872.70001220703125, "manhole_up": "manhole_898_generated", "manhole_dn": "manhole_899_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392356.380438774125651, 5866628.383614298887551 ], [ 1392308.831575774587691, 5866613.373798403888941 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E138", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 875.20001220703125, "elevtn_dn": 875.20001220703125, "invlev_up": 872.70001220703125, "invlev_dn": 872.70001220703125, "manhole_up": "manhole_899_generated", "manhole_dn": "manhole_900_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392308.831575774587691, 5866613.373798403888941 ], [ 1392261.282712775049731, 5866598.363982509821653 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E139", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 875.20001220703125, "elevtn_dn": 928.10003662109375, "invlev_up": 872.70001220703125, "invlev_dn": 925.60003662109375, "manhole_up": "manhole_900_generated", "manhole_dn": "manhole_901_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392261.282712775049731, 5866598.363982509821653 ], [ 1392213.733849775511771, 5866583.354166614823043 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E140", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 928.10003662109375, "elevtn_dn": 928.10003662109375, "invlev_up": 925.60003662109375, "invlev_dn": 925.60003662109375, "manhole_up": "manhole_901_generated", "manhole_dn": "manhole_902_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392213.733849775511771, 5866583.354166614823043 ], [ 1392166.184986775973812, 5866568.344350719824433 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E141", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 928.10003662109375, "elevtn_dn": 936.79998779296875, "invlev_up": 925.60003662109375, "invlev_dn": 934.29998779296875, "manhole_up": "manhole_902_generated", "manhole_dn": "manhole_903_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392166.184986775973812, 5866568.344350719824433 ], [ 1392119.234377897810191, 5866551.59017149079591 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E142", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 936.79998779296875, "elevtn_dn": 936.79998779296875, "invlev_up": 934.29998779296875, "invlev_dn": 934.29998779296875, "manhole_up": "manhole_903_generated", "manhole_dn": "manhole_904_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392119.234377897810191, 5866551.59017149079591 ], [ 1392072.481987217208371, 5866534.25803626794368 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E143", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 936.79998779296875, "elevtn_dn": 929.79998779296875, "invlev_up": 934.29998779296875, "invlev_dn": 927.29998779296875, "manhole_up": "manhole_904_generated", "manhole_dn": "manhole_905_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392072.481987217208371, 5866534.25803626794368 ], [ 1392025.729596536839381, 5866516.925901044160128 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E144", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 929.79998779296875, "elevtn_dn": 892.29998779296875, "invlev_up": 927.29998779296875, "invlev_dn": 889.79998779296875, "manhole_up": "manhole_905_generated", "manhole_dn": "manhole_906_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392025.729596536839381, 5866516.925901044160128 ], [ 1391978.977205856470391, 5866499.593765820376575 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E145", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 892.29998779296875, "elevtn_dn": 911.4000244140625, "invlev_up": 889.79998779296875, "invlev_dn": 908.9000244140625, "manhole_up": "manhole_906_generated", "manhole_dn": "manhole_907_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391978.977205856470391, 5866499.593765820376575 ], [ 1391932.224815175868571, 5866482.261630596593022 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E146", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.4000244140625, "elevtn_dn": 911.4000244140625, "invlev_up": 908.9000244140625, "invlev_dn": 908.9000244140625, "manhole_up": "manhole_907_generated", "manhole_dn": "manhole_908_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391932.224815175868571, 5866482.261630596593022 ], [ 1391885.472424495499581, 5866464.92949537280947 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E147", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.4000244140625, "elevtn_dn": 933.20001220703125, "invlev_up": 908.9000244140625, "invlev_dn": 930.70001220703125, "manhole_up": "manhole_908_generated", "manhole_dn": "manhole_909_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391885.472424495499581, 5866464.92949537280947 ], [ 1391838.720033814897761, 5866447.59736014995724 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E148", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.20001220703125, "elevtn_dn": 933.20001220703125, "invlev_up": 930.70001220703125, "invlev_dn": 930.70001220703125, "manhole_up": "manhole_909_generated", "manhole_dn": "manhole_910_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391838.720033814897761, 5866447.59736014995724 ], [ 1391791.967643134528771, 5866430.265224926173687 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E149", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.20001220703125, "elevtn_dn": 939.4000244140625, "invlev_up": 930.70001220703125, "invlev_dn": 936.9000244140625, "manhole_up": "manhole_910_generated", "manhole_dn": "manhole_911_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391791.967643134528771, 5866430.265224926173687 ], [ 1391745.215252453926951, 5866412.933089702390134 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E150", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 939.4000244140625, "elevtn_dn": 939.4000244140625, "invlev_up": 936.9000244140625, "invlev_dn": 936.9000244140625, "manhole_up": "manhole_911_generated", "manhole_dn": "manhole_912_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391745.215252453926951, 5866412.933089702390134 ], [ 1391698.462861773557961, 5866395.600954478606582 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E151", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 939.4000244140625, "elevtn_dn": 952.70001220703125, "invlev_up": 936.9000244140625, "invlev_dn": 950.20001220703125, "manhole_up": "manhole_912_generated", "manhole_dn": "manhole_913_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391698.462861773557961, 5866395.600954478606582 ], [ 1391651.710471092956141, 5866378.268819254823029 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E152", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.70001220703125, "elevtn_dn": 889.4000244140625, "invlev_up": 950.20001220703125, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_913_generated", "manhole_dn": "manhole_914_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391651.710471092956141, 5866378.268819254823029 ], [ 1391604.958080412587151, 5866360.936684031039476 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E153", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 848.70001220703125, "invlev_up": 886.9000244140625, "invlev_dn": 846.20001220703125, "manhole_up": "manhole_914_generated", "manhole_dn": "manhole_915_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391604.958080412587151, 5866360.936684031039476 ], [ 1391558.205689732218161, 5866343.604548808187246 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E154", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 848.70001220703125, "elevtn_dn": 848.70001220703125, "invlev_up": 846.20001220703125, "invlev_dn": 846.20001220703125, "manhole_up": "manhole_915_generated", "manhole_dn": "manhole_916_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391558.205689732218161, 5866343.604548808187246 ], [ 1391511.453299051616341, 5866326.272413584403694 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E155", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 848.70001220703125, "elevtn_dn": 846.0, "invlev_up": 846.20001220703125, "invlev_dn": 843.5, "manhole_up": "manhole_916_generated", "manhole_dn": "manhole_917_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391511.453299051616341, 5866326.272413584403694 ], [ 1391464.700908371247351, 5866308.940278360620141 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E156", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.0, "elevtn_dn": 846.0, "invlev_up": 843.5, "invlev_dn": 843.5, "manhole_up": "manhole_917_generated", "manhole_dn": "manhole_918_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391464.700908371247351, 5866308.940278360620141 ], [ 1391417.948517690645531, 5866291.608143136836588 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E157", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.0, "elevtn_dn": 849.9000244140625, "invlev_up": 843.5, "invlev_dn": 847.4000244140625, "manhole_up": "manhole_918_generated", "manhole_dn": "manhole_919_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391417.948517690645531, 5866291.608143136836588 ], [ 1391371.196127010276541, 5866274.276007913053036 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E158", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 849.9000244140625, "elevtn_dn": 849.9000244140625, "invlev_up": 847.4000244140625, "invlev_dn": 847.4000244140625, "manhole_up": "manhole_919_generated", "manhole_dn": "manhole_920_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391371.196127010276541, 5866274.276007913053036 ], [ 1391321.986832652939484, 5866269.550851707346737 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E159", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 849.9000244140625, "elevtn_dn": 895.70001220703125, "invlev_up": 847.4000244140625, "invlev_dn": 893.20001220703125, "manhole_up": "manhole_920_generated", "manhole_dn": "manhole_921_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391321.986832652939484, 5866269.550851707346737 ], [ 1391272.147464629728347, 5866268.058758955448866 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E160", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 895.70001220703125, "elevtn_dn": 895.70001220703125, "invlev_up": 893.20001220703125, "invlev_dn": 893.20001220703125, "manhole_up": "manhole_921_generated", "manhole_dn": "manhole_922_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391272.147464629728347, 5866268.058758955448866 ], [ 1391222.30809660628438, 5866266.566666204482317 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E161", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 895.70001220703125, "elevtn_dn": 932.0, "invlev_up": 893.20001220703125, "invlev_dn": 929.5, "manhole_up": "manhole_922_generated", "manhole_dn": "manhole_923_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391222.30809660628438, 5866266.566666204482317 ], [ 1391172.468728582840413, 5866265.074573452584445 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E162", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 932.0, "invlev_up": 929.5, "invlev_dn": 929.5, "manhole_up": "manhole_923_generated", "manhole_dn": "manhole_924_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391172.468728582840413, 5866265.074573452584445 ], [ 1391122.629360559629276, 5866263.582480700686574 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E163", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 915.20001220703125, "invlev_up": 929.5, "invlev_dn": 912.70001220703125, "manhole_up": "manhole_924_generated", "manhole_dn": "manhole_925_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391122.629360559629276, 5866263.582480700686574 ], [ 1391072.789992536185309, 5866262.090387949720025 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E164", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.20001220703125, "elevtn_dn": 880.70001220703125, "invlev_up": 912.70001220703125, "invlev_dn": 878.20001220703125, "manhole_up": "manhole_925_generated", "manhole_dn": "manhole_926_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391072.789992536185309, 5866262.090387949720025 ], [ 1391022.950624512741342, 5866260.598295197822154 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E165", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 880.70001220703125, "elevtn_dn": 880.70001220703125, "invlev_up": 878.20001220703125, "invlev_dn": 878.20001220703125, "manhole_up": "manhole_926_generated", "manhole_dn": "manhole_927_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391022.950624512741342, 5866260.598295197822154 ], [ 1390973.111256489530206, 5866259.106202445924282 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E166", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 880.70001220703125, "elevtn_dn": 889.4000244140625, "invlev_up": 878.20001220703125, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_927_generated", "manhole_dn": "manhole_928_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390973.111256489530206, 5866259.106202445924282 ], [ 1390923.271888466086239, 5866257.614109694957733 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E167", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 889.4000244140625, "invlev_up": 886.9000244140625, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_928_generated", "manhole_dn": "manhole_929_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390923.271888466086239, 5866257.614109694957733 ], [ 1390873.432520442642272, 5866256.122016943059862 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E168", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 935.79998779296875, "invlev_up": 886.9000244140625, "invlev_dn": 933.29998779296875, "manhole_up": "manhole_929_generated", "manhole_dn": "manhole_930_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390873.432520442642272, 5866256.122016943059862 ], [ 1390823.593152419198304, 5866254.62992419116199 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E169", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.79998779296875, "elevtn_dn": 935.79998779296875, "invlev_up": 933.29998779296875, "invlev_dn": 933.29998779296875, "manhole_up": "manhole_930_generated", "manhole_dn": "manhole_931_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390823.593152419198304, 5866254.62992419116199 ], [ 1390773.753784395987168, 5866253.137831440195441 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E170", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.79998779296875, "elevtn_dn": 957.79998779296875, "invlev_up": 933.29998779296875, "invlev_dn": 955.29998779296875, "manhole_up": "manhole_931_generated", "manhole_dn": "manhole_932_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390773.753784395987168, 5866253.137831440195441 ], [ 1390723.914416372543201, 5866251.64573868829757 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E171", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.79998779296875, "elevtn_dn": 957.79998779296875, "invlev_up": 955.29998779296875, "invlev_dn": 955.29998779296875, "manhole_up": "manhole_932_generated", "manhole_dn": "manhole_933_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390723.914416372543201, 5866251.64573868829757 ], [ 1390674.075048349099234, 5866250.153645936399698 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E172", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.79998779296875, "elevtn_dn": 957.0, "invlev_up": 955.29998779296875, "invlev_dn": 954.5, "manhole_up": "manhole_933_generated", "manhole_dn": "manhole_934_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390674.075048349099234, 5866250.153645936399698 ], [ 1390624.235680325888097, 5866248.661553185433149 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E173", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.0, "elevtn_dn": 957.0, "invlev_up": 954.5, "invlev_dn": 954.5, "manhole_up": "manhole_934_generated", "manhole_dn": "manhole_935_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390624.235680325888097, 5866248.661553185433149 ], [ 1390574.39631230244413, 5866247.169460433535278 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E174", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.0, "elevtn_dn": 964.5, "invlev_up": 954.5, "invlev_dn": 962.0, "manhole_up": "manhole_935_generated", "manhole_dn": "manhole_936_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390574.39631230244413, 5866247.169460433535278 ], [ 1390524.556944279000163, 5866245.677367681637406 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E175", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 964.5, "invlev_up": 962.0, "invlev_dn": 962.0, "manhole_up": "manhole_936_generated", "manhole_dn": "manhole_937_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390524.556944279000163, 5866245.677367681637406 ], [ 1390474.717576255789027, 5866244.185274930670857 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E176", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 948.5, "invlev_up": 962.0, "invlev_dn": 946.0, "manhole_up": "manhole_937_generated", "manhole_dn": "manhole_938_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390474.717576255789027, 5866244.185274930670857 ], [ 1390424.87820823234506, 5866242.693182178772986 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E177", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 948.5, "elevtn_dn": 970.10003662109375, "invlev_up": 946.0, "invlev_dn": 967.60003662109375, "manhole_up": "manhole_938_generated", "manhole_dn": "manhole_939_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390424.87820823234506, 5866242.693182178772986 ], [ 1390375.038840208901092, 5866241.201089426875114 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E178", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 970.10003662109375, "elevtn_dn": 970.10003662109375, "invlev_up": 967.60003662109375, "invlev_dn": 967.60003662109375, "manhole_up": "manhole_939_generated", "manhole_dn": "manhole_940_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390375.038840208901092, 5866241.201089426875114 ], [ 1390325.199472185689956, 5866239.708996675908566 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E179", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 970.10003662109375, "elevtn_dn": 975.4000244140625, "invlev_up": 967.60003662109375, "invlev_dn": 972.9000244140625, "manhole_up": "manhole_940_generated", "manhole_dn": "manhole_941_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390325.199472185689956, 5866239.708996675908566 ], [ 1390275.360104162245989, 5866238.216903924010694 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E180", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 975.4000244140625, "elevtn_dn": 975.4000244140625, "invlev_up": 972.9000244140625, "invlev_dn": 972.9000244140625, "manhole_up": "manhole_941_generated", "manhole_dn": "manhole_942_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390275.360104162245989, 5866238.216903924010694 ], [ 1390225.520736138802022, 5866236.724811173044145 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E181", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 975.4000244140625, "elevtn_dn": 1034.5, "invlev_up": 972.9000244140625, "invlev_dn": 1032.0, "manhole_up": "manhole_942_generated", "manhole_dn": "manhole_943_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390225.520736138802022, 5866236.724811173044145 ], [ 1390175.681368115358055, 5866235.232718421146274 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E182", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1034.5, "elevtn_dn": 1034.5, "invlev_up": 1032.0, "invlev_dn": 1032.0, "manhole_up": "manhole_943_generated", "manhole_dn": "manhole_944_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390175.681368115358055, 5866235.232718421146274 ], [ 1390125.842000092146918, 5866233.740625669248402 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E183", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1034.5, "elevtn_dn": 1053.9000244140625, "invlev_up": 1032.0, "invlev_dn": 1051.4000244140625, "manhole_up": "manhole_944_generated", "manhole_dn": "manhole_945_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390125.842000092146918, 5866233.740625669248402 ], [ 1390076.002632068702951, 5866232.248532918281853 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E184", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.9000244140625, "elevtn_dn": 956.9000244140625, "invlev_up": 1051.4000244140625, "invlev_dn": 954.4000244140625, "manhole_up": "manhole_945_generated", "manhole_dn": "manhole_946_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390076.002632068702951, 5866232.248532918281853 ], [ 1390026.163264045258984, 5866230.756440166383982 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E185", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 956.9000244140625, "elevtn_dn": 988.79998779296875, "invlev_up": 954.4000244140625, "invlev_dn": 986.29998779296875, "manhole_up": "manhole_946_generated", "manhole_dn": "manhole_947_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390026.163264045258984, 5866230.756440166383982 ], [ 1389976.323896022047848, 5866229.26434741448611 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E186", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 988.79998779296875, "elevtn_dn": 988.79998779296875, "invlev_up": 986.29998779296875, "invlev_dn": 986.29998779296875, "manhole_up": "manhole_947_generated", "manhole_dn": "manhole_948_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389976.323896022047848, 5866229.26434741448611 ], [ 1389926.48452799860388, 5866227.772254663519561 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E187", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 988.79998779296875, "elevtn_dn": 1051.0999755859375, "invlev_up": 986.29998779296875, "invlev_dn": 1048.5999755859375, "manhole_up": "manhole_948_generated", "manhole_dn": "manhole_949_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389926.48452799860388, 5866227.772254663519561 ], [ 1389876.645159975159913, 5866226.28016191162169 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E188", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1051.0999755859375, "elevtn_dn": 1051.0999755859375, "invlev_up": 1048.5999755859375, "invlev_dn": 1048.5999755859375, "manhole_up": "manhole_949_generated", "manhole_dn": "manhole_950_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389876.645159975159913, 5866226.28016191162169 ], [ 1389826.805791951948777, 5866224.788069159723818 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E189", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1051.0999755859375, "elevtn_dn": 1066.9000244140625, "invlev_up": 1048.5999755859375, "invlev_dn": 1064.4000244140625, "manhole_up": "manhole_950_generated", "manhole_dn": "manhole_951_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389826.805791951948777, 5866224.788069159723818 ], [ 1389776.96642392850481, 5866223.295976408757269 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E190", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1066.9000244140625, "elevtn_dn": 1031.2000732421875, "invlev_up": 1064.4000244140625, "invlev_dn": 1028.7000732421875, "manhole_up": "manhole_951_generated", "manhole_dn": "manhole_952_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389776.96642392850481, 5866223.295976408757269 ], [ 1389727.141182830790058, 5866221.468200048431754 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E191", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1031.2000732421875, "elevtn_dn": 1031.2000732421875, "invlev_up": 1028.7000732421875, "invlev_dn": 1028.7000732421875, "manhole_up": "manhole_952_generated", "manhole_dn": "manhole_953_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389727.141182830790058, 5866221.468200048431754 ], [ 1389677.352675863076001, 5866218.767548334784806 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E192", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1031.2000732421875, "elevtn_dn": 986.60003662109375, "invlev_up": 1028.7000732421875, "invlev_dn": 984.10003662109375, "manhole_up": "manhole_953_generated", "manhole_dn": "manhole_954_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389677.352675863076001, 5866218.767548334784806 ], [ 1389627.564168895594776, 5866216.066896621137857 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E193", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 986.60003662109375, "elevtn_dn": 986.60003662109375, "invlev_up": 984.10003662109375, "invlev_dn": 984.10003662109375, "manhole_up": "manhole_954_generated", "manhole_dn": "manhole_955_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389627.564168895594776, 5866216.066896621137857 ], [ 1389577.775661927880719, 5866213.366244907490909 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E194", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 986.60003662109375, "elevtn_dn": 964.70001220703125, "invlev_up": 984.10003662109375, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_955_generated", "manhole_dn": "manhole_956_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389577.775661927880719, 5866213.366244907490909 ], [ 1389527.987154960166663, 5866210.665593194775283 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E195", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 964.70001220703125, "invlev_up": 962.20001220703125, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_956_generated", "manhole_dn": "manhole_957_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389527.987154960166663, 5866210.665593194775283 ], [ 1389478.198647992452607, 5866207.964941481128335 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E196", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 996.29998779296875, "invlev_up": 962.20001220703125, "invlev_dn": 993.79998779296875, "manhole_up": "manhole_957_generated", "manhole_dn": "manhole_958_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389478.198647992452607, 5866207.964941481128335 ], [ 1389428.41014102473855, 5866205.264289767481387 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E197", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 996.29998779296875, "elevtn_dn": 996.29998779296875, "invlev_up": 993.79998779296875, "invlev_dn": 993.79998779296875, "manhole_up": "manhole_958_generated", "manhole_dn": "manhole_959_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389428.41014102473855, 5866205.264289767481387 ], [ 1389378.621634057024494, 5866202.563638053834438 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E198", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 996.29998779296875, "elevtn_dn": 1030.4000244140625, "invlev_up": 993.79998779296875, "invlev_dn": 1027.9000244140625, "manhole_up": "manhole_959_generated", "manhole_dn": "manhole_960_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389378.621634057024494, 5866202.563638053834438 ], [ 1389328.833127089310437, 5866199.86298634018749 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E199", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1030.4000244140625, "elevtn_dn": 1030.4000244140625, "invlev_up": 1027.9000244140625, "invlev_dn": 1027.9000244140625, "manhole_up": "manhole_960_generated", "manhole_dn": "manhole_961_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389328.833127089310437, 5866199.86298634018749 ], [ 1389279.044620121829212, 5866197.162334626540542 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E200", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1030.4000244140625, "elevtn_dn": 1053.800048828125, "invlev_up": 1027.9000244140625, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_961_generated", "manhole_dn": "manhole_962_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389279.044620121829212, 5866197.162334626540542 ], [ 1389229.256113154115155, 5866194.461682912893593 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E201", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1053.800048828125, "invlev_up": 1051.300048828125, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_962_generated", "manhole_dn": "manhole_963_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389229.256113154115155, 5866194.461682912893593 ], [ 1389179.467606186401099, 5866191.761031199246645 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E202", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1067.5999755859375, "invlev_up": 1051.300048828125, "invlev_dn": 1065.0999755859375, "manhole_up": "manhole_963_generated", "manhole_dn": "manhole_964_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389179.467606186401099, 5866191.761031199246645 ], [ 1389129.679099218687043, 5866189.060379485599697 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E203", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1067.5999755859375, "elevtn_dn": 1070.7000732421875, "invlev_up": 1065.0999755859375, "invlev_dn": 1068.2000732421875, "manhole_up": "manhole_964_generated", "manhole_dn": "manhole_965_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389129.679099218687043, 5866189.060379485599697 ], [ 1389079.890592250972986, 5866186.359727771952748 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E204", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1070.7000732421875, "elevtn_dn": 1070.7000732421875, "invlev_up": 1068.2000732421875, "invlev_dn": 1068.2000732421875, "manhole_up": "manhole_965_generated", "manhole_dn": "manhole_966_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389079.890592250972986, 5866186.359727771952748 ], [ 1389030.10208528325893, 5866183.6590760583058 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E205", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1070.7000732421875, "elevtn_dn": 1075.0, "invlev_up": 1068.2000732421875, "invlev_dn": 1072.5, "manhole_up": "manhole_966_generated", "manhole_dn": "manhole_967_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389030.10208528325893, 5866183.6590760583058 ], [ 1388980.313578315777704, 5866180.958424345590174 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E206", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1075.0, "elevtn_dn": 1075.0, "invlev_up": 1072.5, "invlev_dn": 1072.5, "manhole_up": "manhole_967_generated", "manhole_dn": "manhole_968_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388980.313578315777704, 5866180.958424345590174 ], [ 1388930.525071348063648, 5866178.257772631943226 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E207", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1075.0, "elevtn_dn": 1074.0999755859375, "invlev_up": 1072.5, "invlev_dn": 1071.5999755859375, "manhole_up": "manhole_968_generated", "manhole_dn": "manhole_969_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388930.525071348063648, 5866178.257772631943226 ], [ 1388880.736564380349591, 5866175.557120918296278 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E208", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1074.0999755859375, "elevtn_dn": 1074.0999755859375, "invlev_up": 1071.5999755859375, "invlev_dn": 1071.5999755859375, "manhole_up": "manhole_969_generated", "manhole_dn": "manhole_970_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388880.736564380349591, 5866175.557120918296278 ], [ 1388830.948057412635535, 5866172.856469204649329 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E209", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1074.0999755859375, "elevtn_dn": 1053.800048828125, "invlev_up": 1071.5999755859375, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_970_generated", "manhole_dn": "manhole_971_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388830.948057412635535, 5866172.856469204649329 ], [ 1388781.159550444921479, 5866170.155817491002381 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E210", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1053.800048828125, "invlev_up": 1051.300048828125, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_971_generated", "manhole_dn": "manhole_972_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388781.159550444921479, 5866170.155817491002381 ], [ 1388731.371043477207422, 5866167.455165777355433 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E211", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1017.0, "invlev_up": 1051.300048828125, "invlev_dn": 1014.5, "manhole_up": "manhole_972_generated", "manhole_dn": "manhole_973_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388731.371043477207422, 5866167.455165777355433 ], [ 1388681.582536509493366, 5866164.754514063708484 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E212", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1017.0, "elevtn_dn": 1017.0, "invlev_up": 1014.5, "invlev_dn": 1014.5, "manhole_up": "manhole_973_generated", "manhole_dn": "manhole_974_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388681.582536509493366, 5866164.754514063708484 ], [ 1388631.79402954201214, 5866162.053862350061536 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E213", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1017.0, "elevtn_dn": 973.20001220703125, "invlev_up": 1014.5, "invlev_dn": 970.70001220703125, "manhole_up": "manhole_974_generated", "manhole_dn": "manhole_975_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388631.79402954201214, 5866162.053862350061536 ], [ 1388582.005522574298084, 5866159.353210636414587 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E214", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 973.20001220703125, "elevtn_dn": 973.20001220703125, "invlev_up": 970.70001220703125, "invlev_dn": 970.70001220703125, "manhole_up": "manhole_975_generated", "manhole_dn": "manhole_976_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388582.005522574298084, 5866159.353210636414587 ], [ 1388532.217015606584027, 5866156.652558922767639 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E215", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 973.20001220703125, "elevtn_dn": 935.20001220703125, "invlev_up": 970.70001220703125, "invlev_dn": 932.70001220703125, "manhole_up": "manhole_976_generated", "manhole_dn": "manhole_977_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388532.217015606584027, 5866156.652558922767639 ], [ 1388482.428508638869971, 5866153.951907209120691 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E216", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.20001220703125, "elevtn_dn": 935.20001220703125, "invlev_up": 932.70001220703125, "invlev_dn": 932.70001220703125, "manhole_up": "manhole_977_generated", "manhole_dn": "manhole_978_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388482.428508638869971, 5866153.951907209120691 ], [ 1388432.640001671155915, 5866151.251255496405065 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E217", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.20001220703125, "elevtn_dn": 895.79998779296875, "invlev_up": 932.70001220703125, "invlev_dn": 893.29998779296875, "manhole_up": "manhole_978_generated", "manhole_dn": "manhole_979_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388432.640001671155915, 5866151.251255496405065 ], [ 1388382.851494703441858, 5866148.550603782758117 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E218", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 895.79998779296875, "elevtn_dn": 852.60003662109375, "invlev_up": 893.29998779296875, "invlev_dn": 850.10003662109375, "manhole_up": "manhole_979_generated", "manhole_dn": "manhole_980_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388382.851494703441858, 5866148.550603782758117 ], [ 1388333.062987735960633, 5866145.849952069111168 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E219", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 852.60003662109375, "elevtn_dn": 852.60003662109375, "invlev_up": 850.10003662109375, "invlev_dn": 850.10003662109375, "manhole_up": "manhole_980_generated", "manhole_dn": "manhole_981_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388333.062987735960633, 5866145.849952069111168 ], [ 1388283.274480768246576, 5866143.14930035546422 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E220", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 852.60003662109375, "elevtn_dn": 818.4000244140625, "invlev_up": 850.10003662109375, "invlev_dn": 815.9000244140625, "manhole_up": "manhole_981_generated", "manhole_dn": "manhole_982_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388283.274480768246576, 5866143.14930035546422 ], [ 1388233.48597380053252, 5866140.448648641817272 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E221", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.4000244140625, "elevtn_dn": 818.4000244140625, "invlev_up": 815.9000244140625, "invlev_dn": 815.9000244140625, "manhole_up": "manhole_982_generated", "manhole_dn": "manhole_983_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388233.48597380053252, 5866140.448648641817272 ], [ 1388183.697466832818463, 5866137.747996928170323 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 792.20001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_851_generated", "manhole_dn": "manhole_984_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387913.197226775344461, 5865736.839239663444459 ], [ 1387925.20445894007571, 5865784.545682998374104 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 804.4000244140625, "invlev_up": 792.20001220703125, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_984_generated", "manhole_dn": "manhole_985_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387925.20445894007571, 5865784.545682998374104 ], [ 1387937.21169110503979, 5865832.252126332372427 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_985_generated", "manhole_dn": "manhole_986_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387937.21169110503979, 5865832.252126332372427 ], [ 1387954.8270876808092, 5865878.043407939374447 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_986_generated", "manhole_dn": "manhole_987_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387954.8270876808092, 5865878.043407939374447 ], [ 1387967.620662312954664, 5865925.436966767534614 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 778.20001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_987_generated", "manhole_dn": "manhole_988_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387967.620662312954664, 5865925.436966767534614 ], [ 1387969.561903131194413, 5865974.386314341798425 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_988_generated", "manhole_dn": "manhole_989_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.561903131194413, 5865974.386314341798425 ], [ 1387968.98255812516436, 5866023.571071763522923 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_989_generated", "manhole_dn": "manhole_990_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387968.98255812516436, 5866023.571071763522923 ], [ 1387969.225197304505855, 5866072.657253311946988 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 786.29998779296875, "invlev_up": 775.70001220703125, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_990_generated", "manhole_dn": "manhole_991_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.225197304505855, 5866072.657253311946988 ], [ 1387988.247399942483753, 5866112.298415473662317 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 786.29998779296875, "invlev_up": 783.79998779296875, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_991_generated", "manhole_dn": "manhole_992_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387988.247399942483753, 5866112.298415473662317 ], [ 1388034.037428337847814, 5866130.255607943050563 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 786.29998779296875, "invlev_up": 783.79998779296875, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_992_generated", "manhole_dn": "manhole_993_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388034.037428337847814, 5866130.255607943050563 ], [ 1387988.210684564430267, 5866144.678138472139835 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 803.9000244140625, "invlev_up": 783.79998779296875, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_993_generated", "manhole_dn": "manhole_994_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387988.210684564430267, 5866144.678138472139835 ], [ 1387944.406121137319133, 5866164.065103021450341 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_994_generated", "manhole_dn": "manhole_995_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387944.406121137319133, 5866164.065103021450341 ], [ 1387898.376188111724332, 5866173.560075835324824 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 827.70001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_995_generated", "manhole_dn": "manhole_996_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387898.376188111724332, 5866173.560075835324824 ], [ 1387861.922560503939167, 5866145.113870099186897 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_996_generated", "manhole_dn": "manhole_997_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387861.922560503939167, 5866145.113870099186897 ], [ 1387862.597008766839281, 5866099.287653629668057 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_997_generated", "manhole_dn": "manhole_998_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387862.597008766839281, 5866099.287653629668057 ], [ 1387894.296242429409176, 5866064.31225199252367 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_998_generated", "manhole_dn": "manhole_999_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387894.296242429409176, 5866064.31225199252367 ], [ 1387918.333023339277133, 5866023.860149594023824 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_999_generated", "manhole_dn": "manhole_1000_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387918.333023339277133, 5866023.860149594023824 ], [ 1387925.576027213362977, 5865976.462517648003995 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 804.4000244140625, "invlev_up": 814.20001220703125, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1000_generated", "manhole_dn": "manhole_1001_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387925.576027213362977, 5865976.462517648003995 ], [ 1387926.166851800866425, 5865928.505292822606862 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1001_generated", "manhole_dn": "manhole_1002_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387926.166851800866425, 5865928.505292822606862 ], [ 1387922.175474973395467, 5865880.628693707287312 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1002_generated", "manhole_dn": "manhole_1003_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387922.175474973395467, 5865880.628693707287312 ], [ 1387918.184098146157339, 5865832.752094592899084 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 794.70001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_1003_generated", "manhole_dn": "manhole_1004_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387918.184098146157339, 5865832.752094592899084 ], [ 1387914.316889721900225, 5865784.868878290057182 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 792.20001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_1004_generated", "manhole_dn": "manhole_851_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387914.316889721900225, 5865784.868878290057182 ], [ 1387913.197226775344461, 5865736.839239663444459 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_52_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_52", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.4000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 815.9000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_983_generated", "manhole_dn": "manhole_1005_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388183.697466832818463, 5866137.747996928170323 ], [ 1388133.810787334572524, 5866135.250533932819963 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_52_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_52", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_1005_generated", "manhole_dn": "manhole_1006_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388133.810787334572524, 5866135.250533932819963 ], [ 1388083.924107836093754, 5866132.753070938400924 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_52_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_52", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 786.29998779296875, "invlev_up": 801.4000244140625, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_1006_generated", "manhole_dn": "manhole_992_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388083.924107836093754, 5866132.753070938400924 ], [ 1388034.037428337847814, 5866130.255607943050563 ] ] } }, -{ "type": "Feature", "properties": { "height": 22.5, "bedlev": 865.60003662109375, "width": 60.500781333333329, "branchid": "river_1", "branchtype": "river", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_1", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1394694.070276216836646, 5867648.108302162960172 ], [ 1394694.070276216836646, 5867513.239712204784155 ], [ 1394601.304033889202401, 5867378.373192292638123 ], [ 1394508.537791561568156, 5867243.508742331527174 ], [ 1394415.771549233933911, 5867243.508742331527174 ], [ 1394323.005306906066835, 5867108.646362232975662 ], [ 1394230.23906457843259, 5867108.646362232975662 ], [ 1394137.472822251031175, 5867108.646362232975662 ], [ 1394044.70657992339693, 5866973.78605190385133 ], [ 1393951.940337595762685, 5866973.78605190385133 ], [ 1393859.17409526812844, 5866973.78605190385133 ], [ 1393766.407852940494195, 5866838.927811251021922 ], [ 1393673.641610612627119, 5866838.927811251021922 ], [ 1393580.875368284992874, 5866838.927811251021922 ], [ 1393488.109125957358629, 5866838.927811251021922 ], [ 1393395.342883629724383, 5866838.927811251021922 ], [ 1393302.576641302322969, 5866838.927811251021922 ], [ 1393209.810398974688724, 5866838.927811251021922 ], [ 1393117.044156646821648, 5866704.071640183217824 ], [ 1393024.277914319187403, 5866704.071640183217824 ], [ 1392931.511671991553158, 5866704.071640183217824 ], [ 1392838.745429663918912, 5866704.071640183217824 ], [ 1392745.979187336284667, 5866569.217538607306778 ], [ 1392653.212945008650422, 5866569.217538607306778 ], [ 1392560.446702681016177, 5866569.217538607306778 ], [ 1392467.680460353381932, 5866569.217538607306778 ], [ 1392374.914218025747687, 5866569.217538607306778 ], [ 1392282.147975698113441, 5866434.365506432950497 ], [ 1392189.381733370479196, 5866299.515543567948043 ], [ 1392096.615491042844951, 5866299.515543567948043 ], [ 1392003.849248715210706, 5866299.515543567948043 ], [ 1391911.083006387576461, 5866299.515543567948043 ], [ 1391818.316764059709385, 5866164.667649918235838 ], [ 1391725.55052173207514, 5866164.667649918235838 ], [ 1391632.784279404673725, 5866164.667649918235838 ], [ 1391540.01803707703948, 5866164.667649918235838 ], [ 1391447.251794749405235, 5866164.667649918235838 ], [ 1391354.48555242177099, 5866164.667649918235838 ], [ 1391261.719310093903914, 5866164.667649918235838 ], [ 1391168.953067766269669, 5866164.667649918235838 ], [ 1391076.186825438635424, 5866164.667649918235838 ], [ 1390983.420583111001179, 5866164.667649918235838 ], [ 1390890.654340783366933, 5866164.667649918235838 ], [ 1390797.888098455965519, 5866029.821825394406915 ], [ 1390705.121856128098443, 5866029.821825394406915 ], [ 1390612.355613800464198, 5866029.821825394406915 ], [ 1390519.589371472829953, 5866029.821825394406915 ], [ 1390426.823129145195708, 5866029.821825394406915 ], [ 1390334.056886817561463, 5866029.821825394406915 ], [ 1390241.290644489927217, 5866029.821825394406915 ], [ 1390148.524402162292972, 5865894.978069902397692 ], [ 1390055.758159834658727, 5865894.978069902397692 ], [ 1389962.991917507024482, 5865760.136383352801204 ], [ 1389870.225675179390237, 5865760.136383352801204 ], [ 1389777.459432851755992, 5865760.136383352801204 ], [ 1389684.693190524121746, 5865760.136383352801204 ], [ 1389591.926948196487501, 5865760.136383352801204 ], [ 1389499.160705868853256, 5865625.296765649691224 ], [ 1389406.39446354098618, 5865625.296765649691224 ], [ 1389406.39446354098618, 5865490.459216705523431 ], [ 1389313.628221213351935, 5865355.623736422508955 ], [ 1389313.628221213351935, 5865220.790324714966118 ], [ 1389313.628221213351935, 5865085.958981488831341 ], [ 1389220.86197888571769, 5864951.129706650041044 ], [ 1389128.095736558316275, 5864816.302500107325613 ], [ 1389128.095736558316275, 5864681.477361769415438 ], [ 1389035.32949423068203, 5864546.654291545972228 ], [ 1389128.095736558316275, 5864411.833289342001081 ], [ 1389128.095736558316275, 5864277.014355068095028 ], [ 1389035.32949423068203, 5864142.197488628327847 ], [ 1388942.563251903047785, 5864007.382689936086535 ], [ 1388849.797009575180709, 5863872.569958896376193 ], [ 1388757.030767247546464, 5863872.569958896376193 ], [ 1388664.264524919912219, 5863737.759295416995883 ], [ 1388571.498282592277974, 5863602.950699406675994 ], [ 1388571.498282592277974, 5863468.144170773215592 ], [ 1388571.498282592277974, 5863333.339709427207708 ], [ 1388478.732040264643729, 5863333.339709427207708 ], [ 1388385.965797937009484, 5863198.537315272726119 ], [ 1388293.199555609375238, 5863198.537315272726119 ], [ 1388200.433313281740993, 5863198.537315272726119 ], [ 1388107.667070954106748, 5863063.736988220363855 ], [ 1388014.900828626472503, 5863063.736988220363855 ], [ 1387922.134586298838258, 5863063.736988220363855 ], [ 1387829.368343971204013, 5862928.938728176057339 ], [ 1387736.602101643569767, 5862794.142535050399601 ], [ 1387736.602101643569767, 5862659.348408752121031 ], [ 1387736.602101643569767, 5862524.556349185295403 ], [ 1387643.835859315935522, 5862389.766356259584427 ], [ 1387551.069616988068447, 5862254.978429886512458 ], [ 1387458.303374660667032, 5862254.978429886512458 ], [ 1387365.537132333032787, 5862254.978429886512458 ], [ 1387272.770890005398542, 5862254.978429886512458 ], [ 1387180.004647677764297, 5862254.978429886512458 ], [ 1387087.238405350130051, 5862254.978429886512458 ], [ 1386994.472163022495806, 5862120.192569970153272 ] ] } }, -{ "type": "Feature", "properties": { "height": 13.574996948242188, "bedlev": 813.29998779296875, "width": 63.595319, "branchid": "river_2", "branchtype": "river", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_2", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386066.809739745920524, 5868052.726493230089545 ], [ 1386159.575982073554769, 5868052.726493230089545 ], [ 1386252.342224401189014, 5867917.851692584343255 ], [ 1386345.108466728823259, 5867917.851692584343255 ], [ 1386437.874709056690335, 5867917.851692584343255 ], [ 1386530.64095138432458, 5867917.851692584343255 ], [ 1386623.407193711958826, 5867917.851692584343255 ], [ 1386716.17343603936024, 5867782.978962258435786 ], [ 1386808.939678366994485, 5867782.978962258435786 ], [ 1386901.70592069462873, 5867782.978962258435786 ], [ 1386994.472163022495806, 5867648.108302162960172 ], [ 1387087.238405350130051, 5867648.108302162960172 ], [ 1387180.004647677764297, 5867513.239712204784155 ], [ 1387272.770890005398542, 5867378.373192292638123 ], [ 1387365.537132333032787, 5867243.508742331527174 ], [ 1387458.303374660667032, 5867108.646362232975662 ], [ 1387551.069616988068447, 5867108.646362232975662 ], [ 1387643.835859315935522, 5867108.646362232975662 ], [ 1387736.602101643569767, 5866973.78605190385133 ], [ 1387829.368343971204013, 5866973.78605190385133 ], [ 1387829.368343971204013, 5866838.927811251021922 ], [ 1387829.368343971204013, 5866704.071640183217824 ], [ 1387829.368343971204013, 5866569.217538607306778 ], [ 1387922.134586298838258, 5866434.365506432950497 ], [ 1387922.134586298838258, 5866299.515543567948043 ], [ 1388014.900828626472503, 5866164.667649918235838 ], [ 1388014.900828626472503, 5866029.821825394406915 ], [ 1388014.900828626472503, 5865894.978069902397692 ], [ 1388014.900828626472503, 5865760.136383352801204 ], [ 1387922.134586298838258, 5865625.296765649691224 ], [ 1387922.134586298838258, 5865490.459216705523431 ], [ 1387922.134586298838258, 5865355.623736422508955 ], [ 1387922.134586298838258, 5865220.790324714966118 ], [ 1387922.134586298838258, 5865085.958981488831341 ], [ 1387829.368343971204013, 5864951.129706650041044 ], [ 1387829.368343971204013, 5864816.302500107325613 ], [ 1387829.368343971204013, 5864681.477361769415438 ], [ 1387829.368343971204013, 5864546.654291545972228 ], [ 1387829.368343971204013, 5864411.833289342001081 ], [ 1387829.368343971204013, 5864277.014355068095028 ], [ 1387736.602101643569767, 5864142.197488628327847 ], [ 1387643.835859315935522, 5864007.382689936086535 ], [ 1387551.069616988068447, 5863872.569958896376193 ], [ 1387551.069616988068447, 5863737.759295416995883 ], [ 1387458.303374660667032, 5863602.950699406675994 ], [ 1387365.537132333032787, 5863468.144170773215592 ], [ 1387272.770890005398542, 5863333.339709427207708 ], [ 1387272.770890005398542, 5863198.537315272726119 ], [ 1387180.004647677764297, 5863063.736988220363855 ], [ 1387087.238405350130051, 5862928.938728176057339 ], [ 1386994.472163022495806, 5862794.142535050399601 ], [ 1386901.70592069462873, 5862794.142535050399601 ], [ 1386808.939678366994485, 5862659.348408752121031 ], [ 1386716.17343603936024, 5862524.556349185295403 ], [ 1386716.17343603936024, 5862389.766356259584427 ], [ 1386716.17343603936024, 5862254.978429886512458 ], [ 1386808.939678366994485, 5862254.978429886512458 ], [ 1386901.70592069462873, 5862120.192569970153272 ], [ 1386994.472163022495806, 5862120.192569970153272 ] ] } }, -{ "type": "Feature", "properties": { "height": 21.70001220703125, "bedlev": 952.79998779296875, "width": 50.0, "branchid": "river_3", "branchtype": "river", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_3", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1391540.01803707703948, 5858077.577220032922924 ], [ 1391447.251794749405235, 5858077.577220032922924 ], [ 1391354.48555242177099, 5858077.577220032922924 ], [ 1391261.719310093903914, 5858077.577220032922924 ], [ 1391168.953067766269669, 5858077.577220032922924 ], [ 1391076.186825438635424, 5858212.301128903403878 ], [ 1390983.420583111001179, 5858212.301128903403878 ], [ 1390890.654340783366933, 5858212.301128903403878 ], [ 1390797.888098455965519, 5858077.577220032922924 ], [ 1390705.121856128098443, 5858077.577220032922924 ], [ 1390612.355613800464198, 5858077.577220032922924 ], [ 1390519.589371472829953, 5858077.577220032922924 ], [ 1390426.823129145195708, 5858077.577220032922924 ], [ 1390334.056886817561463, 5857942.855374777689576 ], [ 1390241.290644489927217, 5857942.855374777689576 ], [ 1390148.524402162292972, 5857942.855374777689576 ], [ 1390055.758159834658727, 5857808.135593040846288 ], [ 1389962.991917507024482, 5857808.135593040846288 ], [ 1389962.991917507024482, 5857673.41787473578006 ], [ 1389870.225675179390237, 5857673.41787473578006 ], [ 1389777.459432851755992, 5857673.41787473578006 ], [ 1389684.693190524121746, 5857808.135593040846288 ], [ 1389591.926948196487501, 5857808.135593040846288 ], [ 1389499.160705868853256, 5857808.135593040846288 ], [ 1389406.39446354098618, 5857808.135593040846288 ], [ 1389313.628221213351935, 5857942.855374777689576 ], [ 1389220.86197888571769, 5858077.577220032922924 ], [ 1389128.095736558316275, 5858212.301128903403878 ], [ 1389035.32949423068203, 5858212.301128903403878 ], [ 1388942.563251903047785, 5858347.02710147574544 ], [ 1388849.797009575180709, 5858347.02710147574544 ], [ 1388757.030767247546464, 5858347.02710147574544 ], [ 1388664.264524919912219, 5858481.755137845873833 ], [ 1388571.498282592277974, 5858481.755137845873833 ], [ 1388478.732040264643729, 5858481.755137845873833 ], [ 1388385.965797937009484, 5858481.755137845873833 ], [ 1388293.199555609375238, 5858481.755137845873833 ], [ 1388200.433313281740993, 5858616.485238100402057 ], [ 1388107.667070954106748, 5858751.217402336187661 ], [ 1388014.900828626472503, 5858885.951630645431578 ], [ 1387922.134586298838258, 5858885.951630645431578 ], [ 1387829.368343971204013, 5858885.951630645431578 ], [ 1387736.602101643569767, 5858885.951630645431578 ], [ 1387643.835859315935522, 5858885.951630645431578 ], [ 1387551.069616988068447, 5858885.951630645431578 ], [ 1387458.303374660667032, 5858885.951630645431578 ], [ 1387365.537132333032787, 5858885.951630645431578 ], [ 1387272.770890005398542, 5858885.951630645431578 ], [ 1387180.004647677764297, 5858885.951630645431578 ], [ 1387087.238405350130051, 5858885.951630645431578 ], [ 1386994.472163022495806, 5858885.951630645431578 ], [ 1386901.70592069462873, 5858885.951630645431578 ], [ 1386808.939678366994485, 5858885.951630645431578 ], [ 1386716.17343603936024, 5859020.687923114746809 ], [ 1386623.407193711958826, 5859020.687923114746809 ], [ 1386530.64095138432458, 5859020.687923114746809 ], [ 1386437.874709056690335, 5859020.687923114746809 ], [ 1386345.108466728823259, 5859020.687923114746809 ] ] } }, -{ "type": "Feature", "properties": { "height": 14.050003051757812, "bedlev": 724.29998779296875, "width": 60.93007025, "branchid": "river_4", "branchtype": "river", "branchorder": "1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_4", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386994.472163022495806, 5862120.192569970153272 ], [ 1386901.70592069462873, 5861985.408776421099901 ], [ 1386808.939678366994485, 5861850.627049146220088 ], [ 1386716.17343603936024, 5861715.847388052381575 ], [ 1386716.17343603936024, 5861581.069793051108718 ], [ 1386716.17343603936024, 5861446.294264048337936 ], [ 1386648.271799877518788, 5861347.644815167412162 ] ] } }, -{ "type": "Feature", "properties": { "height": 14.050003051757812, "bedlev": 724.29998779296875, "width": 60.93007025, "branchid": "river_4-1", "branchtype": "river", "branchorder": "1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_4", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386648.271799877518788, 5861347.644815167412162 ], [ 1386623.407193711958826, 5861311.520800951868296 ], [ 1386623.407193711958826, 5861176.749403670430183 ], [ 1386530.64095138432458, 5861176.749403670430183 ], [ 1386437.874709056690335, 5861041.98007211368531 ], [ 1386437.874709056690335, 5860907.212806186638772 ], [ 1386437.874709056690335, 5860772.447605801746249 ], [ 1386437.874709056690335, 5860637.684470863081515 ], [ 1386345.108466728823259, 5860502.92340128030628 ], [ 1386345.108466728823259, 5860368.164396961219609 ], [ 1386252.342224401189014, 5860233.407457816414535 ], [ 1386159.575982073554769, 5860098.652583750896156 ], [ 1386159.575982073554769, 5859963.899774673394859 ], [ 1386159.575982073554769, 5859829.149030494503677 ], [ 1386159.575982073554769, 5859694.40035112015903 ], [ 1386252.342224401189014, 5859559.653736459091306 ], [ 1386252.342224401189014, 5859424.909186420030892 ], [ 1386252.342224401189014, 5859290.166700910776854 ], [ 1386252.342224401189014, 5859155.426279840059578 ], [ 1386345.108466728823259, 5859020.687923114746809 ] ] } }, -{ "type": "Feature", "properties": { "height": 17.349960327148438, "bedlev": 701.4000244140625, "width": 60.93007025, "branchid": "river_5", "branchtype": "river", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_5", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386345.108466728823259, 5859020.687923114746809 ], [ 1386252.342224401189014, 5858885.951630645431578 ], [ 1386159.575982073554769, 5858751.217402336187661 ], [ 1386159.575982073554769, 5858616.485238100402057 ], [ 1386159.575982073554769, 5858481.755137845873833 ], [ 1386159.575982073554769, 5858347.02710147574544 ], [ 1386066.809739745920524, 5858212.301128903403878 ], [ 1385974.043497418286279, 5858212.301128903403878 ], [ 1385881.277255090652034, 5858212.301128903403878 ], [ 1385788.511012763017789, 5858212.301128903403878 ], [ 1385695.744770435383543, 5858212.301128903403878 ], [ 1385602.978528107749298, 5858077.577220032922924 ], [ 1385510.212285780115053, 5857942.855374777689576 ], [ 1385510.212285780115053, 5857808.135593040846288 ], [ 1385417.446043452480808, 5857673.41787473578006 ], [ 1385324.679801124846563, 5857673.41787473578006 ], [ 1385231.913558797212318, 5857538.702219764702022 ], [ 1385231.913558797212318, 5857403.988628041930497 ], [ 1385231.913558797212318, 5857269.277099471539259 ], [ 1385231.913558797212318, 5857134.567633965052664 ], [ 1385324.679801124846563, 5856999.86023142747581 ], [ 1385231.913558797212318, 5856865.154891769401729 ], [ 1385231.913558797212318, 5856730.451614898629487 ], [ 1385139.147316469578072, 5856595.750400722958148 ], [ 1385046.381074141710997, 5856595.750400722958148 ], [ 1384953.614831814309582, 5856461.051249152049422 ], [ 1384860.848589486675337, 5856461.051249152049422 ], [ 1384768.082347159041092, 5856326.354160091839731 ], [ 1384768.082347159041092, 5856191.659133453853428 ], [ 1384675.316104831406847, 5856056.966169144026935 ], [ 1384582.549862503772601, 5856056.966169144026935 ], [ 1384489.783620175905526, 5855922.275267072021961 ], [ 1384397.017377848271281, 5855787.586427145637572 ], [ 1384304.251135520637035, 5855787.586427145637572 ], [ 1384211.48489319300279, 5855652.899649272672832 ], [ 1384118.718650865368545, 5855518.21493336185813 ], [ 1384025.952408537967131, 5855383.532279322855175 ], [ 1383933.186166210100055, 5855248.851687061600387 ], [ 1383840.41992388246581, 5855248.851687061600387 ], [ 1383747.653681554831564, 5855114.1731564886868 ], [ 1383747.653681554831564, 5854979.496687510982156 ], [ 1383747.653681554831564, 5854844.822280039079487 ], [ 1383654.887439227197319, 5854844.822280039079487 ], [ 1383562.121196899563074, 5854710.149933977983892 ], [ 1383469.354954571928829, 5854710.149933977983892 ], [ 1383376.588712244294584, 5854575.479649240151048 ], [ 1383283.822469916660339, 5854440.811425729654729 ], [ 1383191.056227589026093, 5854440.811425729654729 ] ] } } -======= -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_6_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_1_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389238.298387300921604, 5860147.714495398104191 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_6_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 933.5, "invlev_up": 913.4000244140625, "invlev_dn": 931.0, "manhole_up": "manhole_1_generated", "manhole_dn": "manhole_2_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389238.298387300921604, 5860147.714495398104191 ], [ 1389210.947846550960094, 5860184.343885350972414 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_6_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 933.5, "elevtn_dn": 933.5, "invlev_up": 931.0, "invlev_dn": 931.0, "manhole_up": "manhole_2_generated", "manhole_dn": "manhole_3_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389210.947846550960094, 5860184.343885350972414 ], [ 1389186.961922727525234, 5860223.315261371433735 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_6_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 933.5, "elevtn_dn": 935.5, "invlev_up": 931.0, "invlev_dn": 933.0, "manhole_up": "manhole_3_generated", "manhole_dn": "manhole_4_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389186.961922727525234, 5860223.315261371433735 ], [ 1389162.755598766496405, 5860262.142883376218379 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_6_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 935.5, "invlev_up": 933.0, "invlev_dn": 933.0, "manhole_up": "manhole_4_generated", "manhole_dn": "manhole_5_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389162.755598766496405, 5860262.142883376218379 ], [ 1389136.759307563304901, 5860299.80301527120173 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_6_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 936.5, "invlev_up": 933.0, "invlev_dn": 934.0, "manhole_up": "manhole_5_generated", "manhole_dn": "manhole_6_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389136.759307563304901, 5860299.80301527120173 ], [ 1389109.7301227634307, 5860336.652257356792688 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_6_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 936.5, "elevtn_dn": 941.10003662109375, "invlev_up": 934.0, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_6_generated", "manhole_dn": "manhole_7_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389109.7301227634307, 5860336.652257356792688 ], [ 1389073.18478828552179, 5860363.522737024351954 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_6_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_7_generated", "manhole_dn": "manhole_8_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389073.18478828552179, 5860363.522737024351954 ], [ 1389032.546542100608349, 5860384.329287325032055 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_6_E8", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_8_generated", "manhole_dn": "manhole_9_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389032.546542100608349, 5860384.329287325032055 ], [ 1388989.578410296700895, 5860400.071978960186243 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_6_E9", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 951.29998779296875, "invlev_up": 938.60003662109375, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_9_generated", "manhole_dn": "manhole_10_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388989.578410296700895, 5860400.071978960186243 ], [ 1388946.301100668497384, 5860414.883977899327874 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_7_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_11_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389221.905703959986567, 5860123.3256367566064 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_7_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_11_generated", "manhole_dn": "manhole_12_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389221.905703959986567, 5860123.3256367566064 ], [ 1389177.295895804418251, 5860134.962970778346062 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_7_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 919.60003662109375, "invlev_up": 913.4000244140625, "invlev_dn": 917.10003662109375, "manhole_up": "manhole_12_generated", "manhole_dn": "manhole_13_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389177.295895804418251, 5860134.962970778346062 ], [ 1389132.686087648617104, 5860146.600304800085723 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_7_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 919.60003662109375, "elevtn_dn": 919.60003662109375, "invlev_up": 917.10003662109375, "invlev_dn": 917.10003662109375, "manhole_up": "manhole_13_generated", "manhole_dn": "manhole_14_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389132.686087648617104, 5860146.600304800085723 ], [ 1389088.076279493048787, 5860158.237638821825385 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_7_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 919.60003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 917.10003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_14_generated", "manhole_dn": "manhole_15_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389088.076279493048787, 5860158.237638821825385 ], [ 1389044.226173994829878, 5860172.143308508209884 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_7_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 935.60003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_15_generated", "manhole_dn": "manhole_16_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389044.226173994829878, 5860172.143308508209884 ], [ 1389012.527182487538084, 5860198.239755615592003 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_7_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 935.60003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_16_generated", "manhole_dn": "manhole_17_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389012.527182487538084, 5860198.239755615592003 ], [ 1388995.773122631013393, 5860240.481283166445792 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_7_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 945.0, "invlev_up": 935.60003662109375, "invlev_dn": 942.5, "manhole_up": "manhole_17_generated", "manhole_dn": "manhole_18_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388995.773122631013393, 5860240.481283166445792 ], [ 1388973.630034049740061, 5860280.918223639950156 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_7_E8", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.0, "elevtn_dn": 951.29998779296875, "invlev_up": 942.5, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_18_generated", "manhole_dn": "manhole_19_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388973.630034049740061, 5860280.918223639950156 ], [ 1388961.171157888136804, 5860324.081192856654525 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_7_E9", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_19_generated", "manhole_dn": "manhole_20_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388961.171157888136804, 5860324.081192856654525 ], [ 1388955.410555170848966, 5860369.690168970264494 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_7_E10", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_20_generated", "manhole_dn": "manhole_10_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388955.410555170848966, 5860369.690168970264494 ], [ 1388946.301100668497384, 5860414.883977899327874 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 914.5, "invlev_up": 913.4000244140625, "invlev_dn": 912.0, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_21_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389306.50000010849908, 5860083.476415127515793 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 914.5, "elevtn_dn": 914.5, "invlev_up": 912.0, "invlev_dn": 912.0, "manhole_up": "manhole_21_generated", "manhole_dn": "manhole_22_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389306.50000010849908, 5860083.476415127515793 ], [ 1389355.420758404070511, 5860074.630405306816101 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 914.5, "elevtn_dn": 929.9000244140625, "invlev_up": 912.0, "invlev_dn": 927.4000244140625, "manhole_up": "manhole_22_generated", "manhole_dn": "manhole_23_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389355.420758404070511, 5860074.630405306816101 ], [ 1389389.090761042200029, 5860042.4449307853356 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 929.9000244140625, "elevtn_dn": 955.0, "invlev_up": 927.4000244140625, "invlev_dn": 952.5, "manhole_up": "manhole_23_generated", "manhole_dn": "manhole_24_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389389.090761042200029, 5860042.4449307853356 ], [ 1389404.036260401364416, 5859994.775433851405978 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_24_generated", "manhole_dn": "manhole_25_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389404.036260401364416, 5859994.775433851405978 ], [ 1389418.744130451697856, 5859947.032028519548476 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_25_generated", "manhole_dn": "manhole_26_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389418.744130451697856, 5859947.032028519548476 ], [ 1389423.265342897269875, 5859897.853969652205706 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 975.29998779296875, "invlev_up": 952.5, "invlev_dn": 972.79998779296875, "manhole_up": "manhole_26_generated", "manhole_dn": "manhole_27_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389423.265342897269875, 5859897.853969652205706 ], [ 1389395.831073811277747, 5859856.743154510855675 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 975.29998779296875, "elevtn_dn": 963.0, "invlev_up": 972.79998779296875, "invlev_dn": 960.5, "manhole_up": "manhole_27_generated", "manhole_dn": "manhole_28_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389395.831073811277747, 5859856.743154510855675 ], [ 1389350.827042841585353, 5859839.640478814020753 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E8", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 963.0, "elevtn_dn": 963.0, "invlev_up": 960.5, "invlev_dn": 960.5, "manhole_up": "manhole_28_generated", "manhole_dn": "manhole_29_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389350.827042841585353, 5859839.640478814020753 ], [ 1389303.795788601972163, 5859855.887689013034105 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E9", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 963.0, "elevtn_dn": 945.4000244140625, "invlev_up": 960.5, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_29_generated", "manhole_dn": "manhole_30_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389303.795788601972163, 5859855.887689013034105 ], [ 1389256.284586790716276, 5859863.631580747663975 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E10", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 945.4000244140625, "invlev_up": 942.9000244140625, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_30_generated", "manhole_dn": "manhole_31_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389256.284586790716276, 5859863.631580747663975 ], [ 1389227.308454349869862, 5859823.781623384915292 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E11", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 945.4000244140625, "invlev_up": 942.9000244140625, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_31_generated", "manhole_dn": "manhole_32_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389227.308454349869862, 5859823.781623384915292 ], [ 1389202.745489193825051, 5859780.279727600514889 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E12", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 959.10003662109375, "invlev_up": 942.9000244140625, "invlev_dn": 956.60003662109375, "manhole_up": "manhole_32_generated", "manhole_dn": "manhole_33_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389202.745489193825051, 5859780.279727600514889 ], [ 1389178.18252403778024, 5859736.777831817045808 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E13", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 959.10003662109375, "elevtn_dn": 944.79998779296875, "invlev_up": 956.60003662109375, "invlev_dn": 942.29998779296875, "manhole_up": "manhole_33_generated", "manhole_dn": "manhole_34_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389178.18252403778024, 5859736.777831817045808 ], [ 1389155.231297271326184, 5859692.450142606161535 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E14", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 944.79998779296875, "elevtn_dn": 944.79998779296875, "invlev_up": 942.29998779296875, "invlev_dn": 942.29998779296875, "manhole_up": "manhole_34_generated", "manhole_dn": "manhole_35_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389155.231297271326184, 5859692.450142606161535 ], [ 1389141.413412723457441, 5859644.883844587020576 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E15", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 944.79998779296875, "elevtn_dn": 952.4000244140625, "invlev_up": 942.29998779296875, "invlev_dn": 949.9000244140625, "manhole_up": "manhole_35_generated", "manhole_dn": "manhole_36_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389141.413412723457441, 5859644.883844587020576 ], [ 1389151.802280035568401, 5859598.61804121825844 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E16", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.4000244140625, "elevtn_dn": 960.70001220703125, "invlev_up": 949.9000244140625, "invlev_dn": 958.20001220703125, "manhole_up": "manhole_36_generated", "manhole_dn": "manhole_37_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389151.802280035568401, 5859598.61804121825844 ], [ 1389191.073854762827978, 5859569.046822287142277 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E17", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 960.70001220703125, "elevtn_dn": 960.70001220703125, "invlev_up": 958.20001220703125, "invlev_dn": 958.20001220703125, "manhole_up": "manhole_37_generated", "manhole_dn": "manhole_38_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389191.073854762827978, 5859569.046822287142277 ], [ 1389239.915165816899389, 5859563.955490378662944 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E18", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 960.70001220703125, "elevtn_dn": 969.60003662109375, "invlev_up": 958.20001220703125, "invlev_dn": 967.10003662109375, "manhole_up": "manhole_38_generated", "manhole_dn": "manhole_39_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389239.915165816899389, 5859563.955490378662944 ], [ 1389289.757686472963542, 5859566.285022127442062 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E19", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 969.60003662109375, "elevtn_dn": 969.60003662109375, "invlev_up": 967.10003662109375, "invlev_dn": 967.10003662109375, "manhole_up": "manhole_39_generated", "manhole_dn": "manhole_40_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389289.757686472963542, 5859566.285022127442062 ], [ 1389339.615828452631831, 5859566.079234052449465 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E20", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 969.60003662109375, "elevtn_dn": 976.29998779296875, "invlev_up": 967.10003662109375, "invlev_dn": 973.79998779296875, "manhole_up": "manhole_40_generated", "manhole_dn": "manhole_41_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389339.615828452631831, 5859566.079234052449465 ], [ 1389387.354307833593339, 5859551.676988741382957 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E21", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 976.29998779296875, "elevtn_dn": 976.29998779296875, "invlev_up": 973.79998779296875, "invlev_dn": 973.79998779296875, "manhole_up": "manhole_41_generated", "manhole_dn": "manhole_42_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389387.354307833593339, 5859551.676988741382957 ], [ 1389428.692968821851537, 5859524.248876142315567 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E22", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 976.29998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 973.79998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_42_generated", "manhole_dn": "manhole_43_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389428.692968821851537, 5859524.248876142315567 ], [ 1389461.138921525795013, 5859486.477508954703808 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E23", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_43_generated", "manhole_dn": "manhole_44_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389461.138921525795013, 5859486.477508954703808 ], [ 1389482.45163832209073, 5859441.487986368127167 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E24", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_44_generated", "manhole_dn": "manhole_45_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389482.45163832209073, 5859441.487986368127167 ], [ 1389497.215460168197751, 5859393.906833835877478 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E25", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_45_generated", "manhole_dn": "manhole_46_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389497.215460168197751, 5859393.906833835877478 ], [ 1389508.394423164660111, 5859345.216126504354179 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E26", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 954.79998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_46_generated", "manhole_dn": "manhole_47_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389508.394423164660111, 5859345.216126504354179 ], [ 1389518.522437864448875, 5859296.29671473056078 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E27", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 954.79998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_47_generated", "manhole_dn": "manhole_48_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389518.522437864448875, 5859296.29671473056078 ], [ 1389528.588071504374966, 5859247.363727764226496 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E28", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 950.20001220703125, "invlev_up": 954.79998779296875, "invlev_dn": 947.70001220703125, "manhole_up": "manhole_48_generated", "manhole_dn": "manhole_49_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389528.588071504374966, 5859247.363727764226496 ], [ 1389538.653705144301057, 5859198.43074079696089 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E29", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 950.20001220703125, "elevtn_dn": 957.60003662109375, "invlev_up": 947.70001220703125, "invlev_dn": 955.10003662109375, "manhole_up": "manhole_49_generated", "manhole_dn": "manhole_50_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389538.653705144301057, 5859198.43074079696089 ], [ 1389548.719338784459978, 5859149.497753830626607 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E30", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.60003662109375, "elevtn_dn": 957.60003662109375, "invlev_up": 955.10003662109375, "invlev_dn": 955.10003662109375, "manhole_up": "manhole_50_generated", "manhole_dn": "manhole_51_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389548.719338784459978, 5859149.497753830626607 ], [ 1389558.784972424386069, 5859100.564766863361001 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E31", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.60003662109375, "elevtn_dn": 954.79998779296875, "invlev_up": 955.10003662109375, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_51_generated", "manhole_dn": "manhole_52_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389558.784972424386069, 5859100.564766863361001 ], [ 1389568.85060606431216, 5859051.631779897026718 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E32", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 954.79998779296875, "invlev_up": 952.29998779296875, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_52_generated", "manhole_dn": "manhole_53_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389568.85060606431216, 5859051.631779897026718 ], [ 1389578.916239704471081, 5859002.698792929761112 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E33", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 954.79998779296875, "invlev_up": 952.29998779296875, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_53_generated", "manhole_dn": "manhole_54_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389578.916239704471081, 5859002.698792929761112 ], [ 1389588.981873344397172, 5858953.765805963426828 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E34", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 956.10003662109375, "invlev_up": 952.29998779296875, "invlev_dn": 953.60003662109375, "manhole_up": "manhole_54_generated", "manhole_dn": "manhole_55_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389588.981873344397172, 5858953.765805963426828 ], [ 1389599.047506984323263, 5858904.832818996161222 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E35", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 956.10003662109375, "elevtn_dn": 956.10003662109375, "invlev_up": 953.60003662109375, "invlev_dn": 953.60003662109375, "manhole_up": "manhole_55_generated", "manhole_dn": "manhole_56_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389599.047506984323263, 5858904.832818996161222 ], [ 1389613.243873829254881, 5858857.048414096236229 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E36", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 956.10003662109375, "elevtn_dn": 966.29998779296875, "invlev_up": 953.60003662109375, "invlev_dn": 963.79998779296875, "manhole_up": "manhole_56_generated", "manhole_dn": "manhole_57_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389613.243873829254881, 5858857.048414096236229 ], [ 1389631.198101107496768, 5858810.554778259247541 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E37", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 966.29998779296875, "elevtn_dn": 968.70001220703125, "invlev_up": 963.79998779296875, "invlev_dn": 966.20001220703125, "manhole_up": "manhole_57_generated", "manhole_dn": "manhole_58_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389631.198101107496768, 5858810.554778259247541 ], [ 1389656.490605737781152, 5858767.472956065088511 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E38", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 968.70001220703125, "elevtn_dn": 968.70001220703125, "invlev_up": 966.20001220703125, "invlev_dn": 966.20001220703125, "manhole_up": "manhole_58_generated", "manhole_dn": "manhole_59_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389656.490605737781152, 5858767.472956065088511 ], [ 1389681.956975018838421, 5858724.49639992788434 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E39", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 968.70001220703125, "elevtn_dn": 976.10003662109375, "invlev_up": 966.20001220703125, "invlev_dn": 973.60003662109375, "manhole_up": "manhole_59_generated", "manhole_dn": "manhole_60_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389681.956975018838421, 5858724.49639992788434 ], [ 1389708.407580326776952, 5858682.115747822448611 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E40", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 976.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 973.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_60_generated", "manhole_dn": "manhole_61_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389708.407580326776952, 5858682.115747822448611 ], [ 1389734.858185634715483, 5858639.735095717012882 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E41", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 980.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_61_generated", "manhole_dn": "manhole_62_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389734.858185634715483, 5858639.735095717012882 ], [ 1389761.308790942654014, 5858597.354443610645831 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E42", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 980.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_62_generated", "manhole_dn": "manhole_63_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389761.308790942654014, 5858597.354443610645831 ], [ 1389787.759396250825375, 5858554.973791505210102 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E43", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 993.29998779296875, "invlev_up": 980.60003662109375, "invlev_dn": 990.79998779296875, "manhole_up": "manhole_63_generated", "manhole_dn": "manhole_64_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389787.759396250825375, 5858554.973791505210102 ], [ 1389814.210001558763906, 5858512.593139399774373 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E44", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 993.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 990.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_64_generated", "manhole_dn": "manhole_65_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389814.210001558763906, 5858512.593139399774373 ], [ 1389840.660606866702437, 5858470.212487293407321 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E45", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 995.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_65_generated", "manhole_dn": "manhole_66_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389840.660606866702437, 5858470.212487293407321 ], [ 1389867.111212174640968, 5858427.831835187971592 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E46", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 995.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_66_generated", "manhole_dn": "manhole_67_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389867.111212174640968, 5858427.831835187971592 ], [ 1389911.240854029776528, 5858417.074701879173517 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E47", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 1006.2000122070312, "invlev_up": 995.79998779296875, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_67_generated", "manhole_dn": "manhole_68_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389911.240854029776528, 5858417.074701879173517 ], [ 1389940.226093058940023, 5858455.739661679603159 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E48", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1006.2000122070312, "invlev_up": 1003.7000122070312, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_68_generated", "manhole_dn": "manhole_69_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389940.226093058940023, 5858455.739661679603159 ], [ 1389959.842267287895083, 5858501.684845351614058 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E49", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1006.2000122070312, "invlev_up": 1003.7000122070312, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_69_generated", "manhole_dn": "manhole_70_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389959.842267287895083, 5858501.684845351614058 ], [ 1389983.028926897095516, 5858544.760824581608176 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E50", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1036.9000244140625, "invlev_up": 1003.7000122070312, "invlev_dn": 1034.4000244140625, "manhole_up": "manhole_70_generated", "manhole_dn": "manhole_71_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389983.028926897095516, 5858544.760824581608176 ], [ 1390026.879799408372492, 5858567.986969069577754 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E51", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1036.9000244140625, "elevtn_dn": 1036.9000244140625, "invlev_up": 1034.4000244140625, "invlev_dn": 1034.4000244140625, "manhole_up": "manhole_71_generated", "manhole_dn": "manhole_72_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390026.879799408372492, 5858567.986969069577754 ], [ 1390075.455719914287329, 5858577.981817713007331 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E52", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1036.9000244140625, "elevtn_dn": 1032.9000244140625, "invlev_up": 1034.4000244140625, "invlev_dn": 1030.4000244140625, "manhole_up": "manhole_72_generated", "manhole_dn": "manhole_73_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390075.455719914287329, 5858577.981817713007331 ], [ 1390124.934819511603564, 5858584.860858413390815 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E53", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1032.9000244140625, "elevtn_dn": 1032.9000244140625, "invlev_up": 1030.4000244140625, "invlev_dn": 1030.4000244140625, "manhole_up": "manhole_73_generated", "manhole_dn": "manhole_74_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390124.934819511603564, 5858584.860858413390815 ], [ 1390174.385966305155307, 5858591.894069475121796 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E54", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1032.9000244140625, "elevtn_dn": 1016.6000366210938, "invlev_up": 1030.4000244140625, "invlev_dn": 1014.1000366210938, "manhole_up": "manhole_74_generated", "manhole_dn": "manhole_75_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390174.385966305155307, 5858591.894069475121796 ], [ 1390224.28731826832518, 5858594.262458441779017 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E55", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1016.6000366210938, "elevtn_dn": 1016.6000366210938, "invlev_up": 1014.1000366210938, "invlev_dn": 1014.1000366210938, "manhole_up": "manhole_75_generated", "manhole_dn": "manhole_76_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390224.28731826832518, 5858594.262458441779017 ], [ 1390273.630285855382681, 5858589.561945637688041 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E56", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1016.6000366210938, "elevtn_dn": 1012.1000366210938, "invlev_up": 1014.1000366210938, "invlev_dn": 1009.6000366210938, "manhole_up": "manhole_76_generated", "manhole_dn": "manhole_77_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390273.630285855382681, 5858589.561945637688041 ], [ 1390322.239480242831632, 5858578.072306710295379 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E57", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1012.1000366210938, "elevtn_dn": 1012.1000366210938, "invlev_up": 1009.6000366210938, "invlev_dn": 1009.6000366210938, "manhole_up": "manhole_77_generated", "manhole_dn": "manhole_78_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390322.239480242831632, 5858578.072306710295379 ], [ 1390371.99352877959609, 5858575.309522898867726 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E58", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1012.1000366210938, "elevtn_dn": 1011.7000122070312, "invlev_up": 1009.6000366210938, "invlev_dn": 1009.2000122070312, "manhole_up": "manhole_78_generated", "manhole_dn": "manhole_79_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390371.99352877959609, 5858575.309522898867726 ], [ 1390419.13544210139662, 5858559.59311543405056 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E59", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1011.7000122070312, "elevtn_dn": 981.5, "invlev_up": 1009.2000122070312, "invlev_dn": 979.0, "manhole_up": "manhole_79_generated", "manhole_dn": "manhole_80_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390419.13544210139662, 5858559.59311543405056 ], [ 1390453.401623640675098, 5858524.246223840862513 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E60", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 981.5, "elevtn_dn": 995.70001220703125, "invlev_up": 979.0, "invlev_dn": 993.20001220703125, "manhole_up": "manhole_80_generated", "manhole_dn": "manhole_81_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390453.401623640675098, 5858524.246223840862513 ], [ 1390496.749499944737181, 5858504.780008735135198 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E61", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 995.70001220703125, "elevtn_dn": 995.70001220703125, "invlev_up": 993.20001220703125, "invlev_dn": 993.20001220703125, "manhole_up": "manhole_81_generated", "manhole_dn": "manhole_82_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390496.749499944737181, 5858504.780008735135198 ], [ 1390546.470755147282034, 5858499.993151630274951 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E62", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 995.70001220703125, "elevtn_dn": 1005.9000244140625, "invlev_up": 993.20001220703125, "invlev_dn": 1003.4000244140625, "manhole_up": "manhole_82_generated", "manhole_dn": "manhole_83_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390546.470755147282034, 5858499.993151630274951 ], [ 1390596.395264241611585, 5858498.177226040512323 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E63", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1005.9000244140625, "elevtn_dn": 1005.9000244140625, "invlev_up": 1003.4000244140625, "invlev_dn": 1003.4000244140625, "manhole_up": "manhole_83_generated", "manhole_dn": "manhole_84_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390596.395264241611585, 5858498.177226040512323 ], [ 1390646.319773336173967, 5858496.361300451681018 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E64", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1005.9000244140625, "elevtn_dn": 1013.6000366210938, "invlev_up": 1003.4000244140625, "invlev_dn": 1011.1000366210938, "manhole_up": "manhole_84_generated", "manhole_dn": "manhole_85_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390646.319773336173967, 5858496.361300451681018 ], [ 1390696.244282430503517, 5858494.545374862849712 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E65", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1013.6000366210938, "elevtn_dn": 1013.6000366210938, "invlev_up": 1011.1000366210938, "invlev_dn": 1011.1000366210938, "manhole_up": "manhole_85_generated", "manhole_dn": "manhole_86_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390696.244282430503517, 5858494.545374862849712 ], [ 1390746.168791524833068, 5858492.729449273087084 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E66", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1013.6000366210938, "elevtn_dn": 1019.1000366210938, "invlev_up": 1011.1000366210938, "invlev_dn": 1016.6000366210938, "manhole_up": "manhole_86_generated", "manhole_dn": "manhole_87_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390746.168791524833068, 5858492.729449273087084 ], [ 1390796.09330061939545, 5858490.913523684255779 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E67", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1019.1000366210938, "elevtn_dn": 1025.800048828125, "invlev_up": 1016.6000366210938, "invlev_dn": 1023.300048828125, "manhole_up": "manhole_87_generated", "manhole_dn": "manhole_88_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390796.09330061939545, 5858490.913523684255779 ], [ 1390846.017809713725001, 5858489.097598095424473 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E68", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1025.800048828125, "elevtn_dn": 1025.800048828125, "invlev_up": 1023.300048828125, "invlev_dn": 1023.300048828125, "manhole_up": "manhole_88_generated", "manhole_dn": "manhole_89_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390846.017809713725001, 5858489.097598095424473 ], [ 1390895.942318808054551, 5858487.281672505661845 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E69", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1025.800048828125, "elevtn_dn": 1029.2000732421875, "invlev_up": 1023.300048828125, "invlev_dn": 1026.7000732421875, "manhole_up": "manhole_89_generated", "manhole_dn": "manhole_90_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390895.942318808054551, 5858487.281672505661845 ], [ 1390945.364988021552563, 5858492.061225635930896 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E70", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1029.2000732421875, "elevtn_dn": 1029.2000732421875, "invlev_up": 1026.7000732421875, "invlev_dn": 1026.7000732421875, "manhole_up": "manhole_90_generated", "manhole_dn": "manhole_91_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390945.364988021552563, 5858492.061225635930896 ], [ 1390994.440001817885786, 5858501.409873396158218 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E71", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1029.2000732421875, "elevtn_dn": 1033.2000732421875, "invlev_up": 1026.7000732421875, "invlev_dn": 1030.7000732421875, "manhole_up": "manhole_91_generated", "manhole_dn": "manhole_92_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390994.440001817885786, 5858501.409873396158218 ], [ 1391040.341196772176772, 5858520.979841153137386 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E72", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1033.2000732421875, "elevtn_dn": 1033.2000732421875, "invlev_up": 1030.7000732421875, "invlev_dn": 1030.7000732421875, "manhole_up": "manhole_92_generated", "manhole_dn": "manhole_93_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391040.341196772176772, 5858520.979841153137386 ], [ 1391086.683747049886733, 5858538.717575071379542 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E73", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1033.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1030.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_93_generated", "manhole_dn": "manhole_94_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391086.683747049886733, 5858538.717575071379542 ], [ 1391131.822940095094964, 5858523.93243224080652 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E74", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_94_generated", "manhole_dn": "manhole_95_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391131.822940095094964, 5858523.93243224080652 ], [ 1391153.157672074623406, 5858479.460670891217887 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E75", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_95_generated", "manhole_dn": "manhole_96_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391153.157672074623406, 5858479.460670891217887 ], [ 1391192.49590603238903, 5858451.67839205916971 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E76", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1044.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1041.7000732421875, "manhole_up": "manhole_96_generated", "manhole_dn": "manhole_97_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391192.49590603238903, 5858451.67839205916971 ], [ 1391240.64117361814715, 5858438.460245226509869 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E77", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1044.2000732421875, "elevtn_dn": 1044.2000732421875, "invlev_up": 1041.7000732421875, "invlev_dn": 1041.7000732421875, "manhole_up": "manhole_97_generated", "manhole_dn": "manhole_98_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391240.64117361814715, 5858438.460245226509869 ], [ 1391289.211760010803118, 5858426.770406410098076 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E78", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1044.2000732421875, "elevtn_dn": 1060.0999755859375, "invlev_up": 1041.7000732421875, "invlev_dn": 1057.5999755859375, "manhole_up": "manhole_98_generated", "manhole_dn": "manhole_99_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391289.211760010803118, 5858426.770406410098076 ], [ 1391337.782346403226256, 5858415.080567593686283 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E79", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1060.0999755859375, "elevtn_dn": 1023.0, "invlev_up": 1057.5999755859375, "invlev_dn": 1020.5, "manhole_up": "manhole_99_generated", "manhole_dn": "manhole_100_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391337.782346403226256, 5858415.080567593686283 ], [ 1391386.352932795882225, 5858403.390728777274489 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E80", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1023.0, "elevtn_dn": 1032.7000732421875, "invlev_up": 1020.5, "invlev_dn": 1030.2000732421875, "manhole_up": "manhole_100_generated", "manhole_dn": "manhole_101_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391386.352932795882225, 5858403.390728777274489 ], [ 1391434.923519188305363, 5858391.700889961794019 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E81", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1032.7000732421875, "elevtn_dn": 1032.7000732421875, "invlev_up": 1030.2000732421875, "invlev_dn": 1030.2000732421875, "manhole_up": "manhole_101_generated", "manhole_dn": "manhole_102_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391434.923519188305363, 5858391.700889961794019 ], [ 1391483.494105580961332, 5858380.011051145382226 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E82", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1032.7000732421875, "elevtn_dn": 1040.7000732421875, "invlev_up": 1030.2000732421875, "invlev_dn": 1038.2000732421875, "manhole_up": "manhole_102_generated", "manhole_dn": "manhole_103_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391483.494105580961332, 5858380.011051145382226 ], [ 1391532.464345134794712, 5858375.802092345431447 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E83", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1040.7000732421875, "elevtn_dn": 1040.7000732421875, "invlev_up": 1038.2000732421875, "invlev_dn": 1038.2000732421875, "manhole_up": "manhole_103_generated", "manhole_dn": "manhole_104_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391532.464345134794712, 5858375.802092345431447 ], [ 1391579.680508555145934, 5858389.753166117705405 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E84", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1040.7000732421875, "elevtn_dn": 1094.5999755859375, "invlev_up": 1038.2000732421875, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_104_generated", "manhole_dn": "manhole_105_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391579.680508555145934, 5858389.753166117705405 ], [ 1391615.043221722124144, 5858422.374543751589954 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E85", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1094.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_105_generated", "manhole_dn": "manhole_106_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391615.043221722124144, 5858422.374543751589954 ], [ 1391633.654095822479576, 5858468.206737855449319 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E86", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1094.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_106_generated", "manhole_dn": "manhole_107_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391633.654095822479576, 5858468.206737855449319 ], [ 1391675.556871910346672, 5858492.042518986389041 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E87", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1100.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1098.0999755859375, "manhole_up": "manhole_107_generated", "manhole_dn": "manhole_108_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391675.556871910346672, 5858492.042518986389041 ], [ 1391725.165284683462232, 5858493.223410680890083 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E88", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1100.5999755859375, "elevtn_dn": 1092.7000732421875, "invlev_up": 1098.0999755859375, "invlev_dn": 1090.2000732421875, "manhole_up": "manhole_108_generated", "manhole_dn": "manhole_109_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391725.165284683462232, 5858493.223410680890083 ], [ 1391774.025632579578087, 5858482.968163449317217 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E89", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1092.7000732421875, "elevtn_dn": 1092.7000732421875, "invlev_up": 1090.2000732421875, "invlev_dn": 1090.2000732421875, "manhole_up": "manhole_109_generated", "manhole_dn": "manhole_110_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391774.025632579578087, 5858482.968163449317217 ], [ 1391822.748904443578795, 5858472.800456050783396 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E90", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1092.7000732421875, "elevtn_dn": 1086.5, "invlev_up": 1090.2000732421875, "invlev_dn": 1084.0, "manhole_up": "manhole_110_generated", "manhole_dn": "manhole_111_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391822.748904443578795, 5858472.800456050783396 ], [ 1391872.520155652426183, 5858474.254766616038978 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E91", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1086.5, "elevtn_dn": 1086.5, "invlev_up": 1084.0, "invlev_dn": 1084.0, "manhole_up": "manhole_111_generated", "manhole_dn": "manhole_112_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391872.520155652426183, 5858474.254766616038978 ], [ 1391922.32820742437616, 5858478.116394865326583 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E92", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1086.5, "elevtn_dn": 1097.300048828125, "invlev_up": 1084.0, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_112_generated", "manhole_dn": "manhole_113_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391922.32820742437616, 5858478.116394865326583 ], [ 1391972.136259196558967, 5858481.978023114614189 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E93", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_113_generated", "manhole_dn": "manhole_114_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391972.136259196558967, 5858481.978023114614189 ], [ 1392014.088137687649578, 5858507.265420926734805 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E94", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_114_generated", "manhole_dn": "manhole_115_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392014.088137687649578, 5858507.265420926734805 ], [ 1392052.00577615830116, 5858538.949620860628784 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E95", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_115_generated", "manhole_dn": "manhole_116_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392052.00577615830116, 5858538.949620860628784 ], [ 1392100.993319420609623, 5858548.746293722651899 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E96", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1135.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1132.800048828125, "manhole_up": "manhole_116_generated", "manhole_dn": "manhole_117_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392100.993319420609623, 5858548.746293722651899 ], [ 1392149.980862683150917, 5858558.542966585606337 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E97", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1135.300048828125, "elevtn_dn": 1135.300048828125, "invlev_up": 1132.800048828125, "invlev_dn": 1132.800048828125, "manhole_up": "manhole_117_generated", "manhole_dn": "manhole_118_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392149.980862683150917, 5858558.542966585606337 ], [ 1392198.767287699971348, 5858569.25206732749939 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E98", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1135.300048828125, "elevtn_dn": 1137.5999755859375, "invlev_up": 1132.800048828125, "invlev_dn": 1135.0999755859375, "manhole_up": "manhole_118_generated", "manhole_dn": "manhole_119_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392198.767287699971348, 5858569.25206732749939 ], [ 1392247.333906656363979, 5858580.958378325216472 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E99", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1137.5999755859375, "elevtn_dn": 1137.5999755859375, "invlev_up": 1135.0999755859375, "invlev_dn": 1135.0999755859375, "manhole_up": "manhole_119_generated", "manhole_dn": "manhole_120_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392247.333906656363979, 5858580.958378325216472 ], [ 1392295.900525612989441, 5858592.664689323864877 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E100", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1137.5999755859375, "elevtn_dn": 1145.0999755859375, "invlev_up": 1135.0999755859375, "invlev_dn": 1142.5999755859375, "manhole_up": "manhole_120_generated", "manhole_dn": "manhole_121_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392295.900525612989441, 5858592.664689323864877 ], [ 1392344.467144569614902, 5858604.371000322513282 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E101", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1145.0999755859375, "elevtn_dn": 1145.0999755859375, "invlev_up": 1142.5999755859375, "invlev_dn": 1142.5999755859375, "manhole_up": "manhole_121_generated", "manhole_dn": "manhole_122_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392344.467144569614902, 5858604.371000322513282 ], [ 1392389.908255772199482, 5858624.575613909401 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E102", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1145.0999755859375, "elevtn_dn": 1140.5, "invlev_up": 1142.5999755859375, "invlev_dn": 1138.0, "manhole_up": "manhole_122_generated", "manhole_dn": "manhole_123_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392389.908255772199482, 5858624.575613909401 ], [ 1392425.081700494978577, 5858659.315580372698605 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E103", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1140.5, "elevtn_dn": 1169.300048828125, "invlev_up": 1138.0, "invlev_dn": 1166.800048828125, "manhole_up": "manhole_123_generated", "manhole_dn": "manhole_124_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392425.081700494978577, 5858659.315580372698605 ], [ 1392458.203119478421286, 5858696.715123130939901 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E104", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1169.300048828125, "elevtn_dn": 1169.300048828125, "invlev_up": 1166.800048828125, "invlev_dn": 1166.800048828125, "manhole_up": "manhole_124_generated", "manhole_dn": "manhole_125_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392458.203119478421286, 5858696.715123130939901 ], [ 1392491.324538461863995, 5858734.114665890112519 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E105", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1169.300048828125, "elevtn_dn": 1165.5, "invlev_up": 1166.800048828125, "invlev_dn": 1163.0, "manhole_up": "manhole_125_generated", "manhole_dn": "manhole_126_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392491.324538461863995, 5858734.114665890112519 ], [ 1392528.963966277893633, 5858766.460637149401009 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E106", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1165.5, "elevtn_dn": 1165.5, "invlev_up": 1163.0, "invlev_dn": 1163.0, "manhole_up": "manhole_126_generated", "manhole_dn": "manhole_127_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392528.963966277893633, 5858766.460637149401009 ], [ 1392573.284122244687751, 5858789.391092935577035 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E107", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1165.5, "elevtn_dn": 1157.0999755859375, "invlev_up": 1163.0, "invlev_dn": 1154.5999755859375, "manhole_up": "manhole_127_generated", "manhole_dn": "manhole_128_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392573.284122244687751, 5858789.391092935577035 ], [ 1392618.033192394766957, 5858811.600886153057218 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E108", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1157.0999755859375, "elevtn_dn": 1184.800048828125, "invlev_up": 1154.5999755859375, "invlev_dn": 1182.300048828125, "manhole_up": "manhole_128_generated", "manhole_dn": "manhole_129_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392618.033192394766957, 5858811.600886153057218 ], [ 1392666.730896146036685, 5858821.011833874508739 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E109", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1184.800048828125, "elevtn_dn": 1141.2000732421875, "invlev_up": 1182.300048828125, "invlev_dn": 1138.7000732421875, "manhole_up": "manhole_129_generated", "manhole_dn": "manhole_130_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392666.730896146036685, 5858821.011833874508739 ], [ 1392714.397227015113458, 5858809.184477739967406 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E110", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1141.2000732421875, "elevtn_dn": 1141.2000732421875, "invlev_up": 1138.7000732421875, "invlev_dn": 1138.7000732421875, "manhole_up": "manhole_130_generated", "manhole_dn": "manhole_131_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392714.397227015113458, 5858809.184477739967406 ], [ 1392761.799294820055366, 5858794.231293976306915 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E111", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1141.2000732421875, "elevtn_dn": 1137.4000244140625, "invlev_up": 1138.7000732421875, "invlev_dn": 1134.9000244140625, "manhole_up": "manhole_131_generated", "manhole_dn": "manhole_132_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392761.799294820055366, 5858794.231293976306915 ], [ 1392810.095712865469977, 5858797.830352782271802 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E112", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1137.4000244140625, "elevtn_dn": 1137.4000244140625, "invlev_up": 1134.9000244140625, "invlev_dn": 1134.9000244140625, "manhole_up": "manhole_132_generated", "manhole_dn": "manhole_133_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392810.095712865469977, 5858797.830352782271802 ], [ 1392855.660074200481176, 5858817.529770986177027 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E113", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1137.4000244140625, "elevtn_dn": 1169.5, "invlev_up": 1134.9000244140625, "invlev_dn": 1167.0, "manhole_up": "manhole_133_generated", "manhole_dn": "manhole_134_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392855.660074200481176, 5858817.529770986177027 ], [ 1392904.672455, 5858826.347064822912216 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E114", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_134_generated", "manhole_dn": "manhole_135_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392904.672455, 5858826.347064822912216 ], [ 1392949.505032581742853, 5858846.393358059227467 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E115", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_135_generated", "manhole_dn": "manhole_136_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392949.505032581742853, 5858846.393358059227467 ], [ 1392993.956312821945176, 5858868.358838438987732 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E116", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_136_generated", "manhole_dn": "manhole_137_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392993.956312821945176, 5858868.358838438987732 ], [ 1393042.160067020915449, 5858881.479519641026855 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E117", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1162.0, "invlev_up": 1167.0, "invlev_dn": 1159.5, "manhole_up": "manhole_137_generated", "manhole_dn": "manhole_138_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393042.160067020915449, 5858881.479519641026855 ], [ 1393090.363821219652891, 5858894.600200843065977 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E118", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1162.0, "elevtn_dn": 1162.0, "invlev_up": 1159.5, "invlev_dn": 1159.5, "manhole_up": "manhole_138_generated", "manhole_dn": "manhole_139_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393090.363821219652891, 5858894.600200843065977 ], [ 1393138.877780271228403, 5858905.382868006825447 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E119", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1162.0, "elevtn_dn": 1152.0999755859375, "invlev_up": 1159.5, "invlev_dn": 1149.5999755859375, "manhole_up": "manhole_139_generated", "manhole_dn": "manhole_140_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393138.877780271228403, 5858905.382868006825447 ], [ 1393188.835210436256602, 5858905.286093098111451 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E120", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1152.0999755859375, "elevtn_dn": 1152.0999755859375, "invlev_up": 1149.5999755859375, "invlev_dn": 1149.5999755859375, "manhole_up": "manhole_140_generated", "manhole_dn": "manhole_141_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393188.835210436256602, 5858905.286093098111451 ], [ 1393237.248238409170881, 5858916.599204055964947 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E121", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1152.0999755859375, "elevtn_dn": 1147.300048828125, "invlev_up": 1149.5999755859375, "invlev_dn": 1144.800048828125, "manhole_up": "manhole_141_generated", "manhole_dn": "manhole_142_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393237.248238409170881, 5858916.599204055964947 ], [ 1393278.15638761385344, 5858943.766047672368586 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E122", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1147.300048828125, "elevtn_dn": 1182.7000732421875, "invlev_up": 1144.800048828125, "invlev_dn": 1180.2000732421875, "manhole_up": "manhole_142_generated", "manhole_dn": "manhole_143_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393278.15638761385344, 5858943.766047672368586 ], [ 1393316.553906054003164, 5858975.725158606655896 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E123", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1182.7000732421875, "elevtn_dn": 1180.0999755859375, "invlev_up": 1180.2000732421875, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_143_generated", "manhole_dn": "manhole_144_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393316.553906054003164, 5858975.725158606655896 ], [ 1393354.951424494385719, 5859007.684269540011883 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E124", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1180.0999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_144_generated", "manhole_dn": "manhole_145_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393354.951424494385719, 5859007.684269540011883 ], [ 1393393.348942934535444, 5859039.643380474299192 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E125", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1180.0999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_145_generated", "manhole_dn": "manhole_146_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393393.348942934535444, 5859039.643380474299192 ], [ 1393431.746461374685168, 5859071.602491408586502 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E126", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_146_generated", "manhole_dn": "manhole_147_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393431.746461374685168, 5859071.602491408586502 ], [ 1393472.672340910183266, 5859100.089053857140243 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E127", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1200.0999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_147_generated", "manhole_dn": "manhole_148_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393472.672340910183266, 5859100.089053857140243 ], [ 1393507.678647378925234, 5859134.262682756409049 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E128", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1200.0999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_148_generated", "manhole_dn": "manhole_149_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393507.678647378925234, 5859134.262682756409049 ], [ 1393492.637579936999828, 5859179.667013085447252 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E129", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1232.300048828125, "invlev_up": 1200.0999755859375, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_149_generated", "manhole_dn": "manhole_150_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393492.637579936999828, 5859179.667013085447252 ], [ 1393472.727902054553851, 5859225.064155456610024 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E130", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_150_generated", "manhole_dn": "manhole_151_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393472.727902054553851, 5859225.064155456610024 ], [ 1393467.563765458529815, 5859274.587596206925809 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E131", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_151_generated", "manhole_dn": "manhole_152_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393467.563765458529815, 5859274.587596206925809 ], [ 1393473.51405850565061, 5859323.8850102070719 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E132", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_152_generated", "manhole_dn": "manhole_153_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393473.51405850565061, 5859323.8850102070719 ], [ 1393507.773820924572647, 5859356.614802500233054 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E133", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1214.800048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1212.300048828125, "manhole_up": "manhole_153_generated", "manhole_dn": "manhole_154_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393507.773820924572647, 5859356.614802500233054 ], [ 1393555.824224345618859, 5859349.253152369521558 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E134", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1214.800048828125, "elevtn_dn": 1214.800048828125, "invlev_up": 1212.300048828125, "invlev_dn": 1212.300048828125, "manhole_up": "manhole_154_generated", "manhole_dn": "manhole_155_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393555.824224345618859, 5859349.253152369521558 ], [ 1393591.00338595919311, 5859314.794959847815335 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E135", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1214.800048828125, "elevtn_dn": 1191.0999755859375, "invlev_up": 1212.300048828125, "invlev_dn": 1188.5999755859375, "manhole_up": "manhole_155_generated", "manhole_dn": "manhole_156_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393591.00338595919311, 5859314.794959847815335 ], [ 1393633.153639519121498, 5859288.066565420478582 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E136", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1191.0999755859375, "elevtn_dn": 1191.0999755859375, "invlev_up": 1188.5999755859375, "invlev_dn": 1188.5999755859375, "manhole_up": "manhole_156_generated", "manhole_dn": "manhole_157_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393633.153639519121498, 5859288.066565420478582 ], [ 1393673.123904188396409, 5859258.097712650895119 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E137", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1191.0999755859375, "elevtn_dn": 1144.300048828125, "invlev_up": 1188.5999755859375, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_157_generated", "manhole_dn": "manhole_158_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393673.123904188396409, 5859258.097712650895119 ], [ 1393720.523227575467899, 5859244.838272913359106 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E138", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1144.300048828125, "invlev_up": 1141.800048828125, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_158_generated", "manhole_dn": "manhole_159_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393720.523227575467899, 5859244.838272913359106 ], [ 1393765.710014625452459, 5859224.569284616038203 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E139", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1144.300048828125, "invlev_up": 1141.800048828125, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_159_generated", "manhole_dn": "manhole_160_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393765.710014625452459, 5859224.569284616038203 ], [ 1393806.409210936399177, 5859195.609256223775446 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E140", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1112.5, "invlev_up": 1141.800048828125, "invlev_dn": 1110.0, "manhole_up": "manhole_160_generated", "manhole_dn": "manhole_161_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393806.409210936399177, 5859195.609256223775446 ], [ 1393846.866742686368525, 5859166.301538489758968 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1045", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 968.29998779296875, "invlev_up": 965.79998779296875, "invlev_dn": 965.79998779296875, "manhole_up": "manhole_162_generated", "manhole_dn": "manhole_163_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388521.257592596346512, 5855362.027613477781415 ], [ 1388472.030306826578453, 5855370.543775821104646 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1046", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 968.29998779296875, "invlev_up": 965.79998779296875, "invlev_dn": 965.79998779296875, "manhole_up": "manhole_163_generated", "manhole_dn": "manhole_164_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388472.030306826578453, 5855370.543775821104646 ], [ 1388439.000347282737494, 5855407.802592809312046 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1047", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 964.5, "invlev_up": 965.79998779296875, "invlev_dn": 962.0, "manhole_up": "manhole_164_generated", "manhole_dn": "manhole_165_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388439.000347282737494, 5855407.802592809312046 ], [ 1388400.196091859601438, 5855436.014134516008198 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1048", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 964.5, "invlev_up": 962.0, "invlev_dn": 962.0, "manhole_up": "manhole_165_generated", "manhole_dn": "manhole_166_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388400.196091859601438, 5855436.014134516008198 ], [ 1388351.33823574683629, 5855446.634319253265858 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1049", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 981.9000244140625, "invlev_up": 962.0, "invlev_dn": 979.4000244140625, "manhole_up": "manhole_166_generated", "manhole_dn": "manhole_167_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388351.33823574683629, 5855446.634319253265858 ], [ 1388301.961881892289966, 5855453.847477887757123 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1050", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 981.9000244140625, "elevtn_dn": 981.9000244140625, "invlev_up": 979.4000244140625, "invlev_dn": 979.4000244140625, "manhole_up": "manhole_167_generated", "manhole_dn": "manhole_168_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388301.961881892289966, 5855453.847477887757123 ], [ 1388252.297577269142494, 5855451.260453455150127 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1051", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 981.9000244140625, "elevtn_dn": 973.70001220703125, "invlev_up": 979.4000244140625, "invlev_dn": 971.20001220703125, "manhole_up": "manhole_168_generated", "manhole_dn": "manhole_169_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388252.297577269142494, 5855451.260453455150127 ], [ 1388202.479659734526649, 5855455.508814659900963 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1052", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 973.70001220703125, "elevtn_dn": 961.70001220703125, "invlev_up": 971.20001220703125, "invlev_dn": 959.20001220703125, "manhole_up": "manhole_169_generated", "manhole_dn": "manhole_170_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388202.479659734526649, 5855455.508814659900963 ], [ 1388152.683455461403355, 5855460.015516467392445 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1053", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 961.70001220703125, "elevtn_dn": 961.70001220703125, "invlev_up": 959.20001220703125, "invlev_dn": 959.20001220703125, "manhole_up": "manhole_170_generated", "manhole_dn": "manhole_171_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388152.683455461403355, 5855460.015516467392445 ], [ 1388104.622611842118204, 5855473.253733876161277 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1054", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 961.70001220703125, "elevtn_dn": 945.79998779296875, "invlev_up": 959.20001220703125, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_171_generated", "manhole_dn": "manhole_172_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388104.622611842118204, 5855473.253733876161277 ], [ 1388057.00563437351957, 5855488.445189393125474 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1055", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 945.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_172_generated", "manhole_dn": "manhole_173_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388057.00563437351957, 5855488.445189393125474 ], [ 1388011.292356542311609, 5855508.700276436284184 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1056", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 945.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_173_generated", "manhole_dn": "manhole_174_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388011.292356542311609, 5855508.700276436284184 ], [ 1387969.221702651120722, 5855535.246164590120316 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1057", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 930.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 928.29998779296875, "manhole_up": "manhole_174_generated", "manhole_dn": "manhole_175_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.221702651120722, 5855535.246164590120316 ], [ 1387935.863196024205536, 5855572.491061648353934 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1058", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 930.79998779296875, "elevtn_dn": 957.10003662109375, "invlev_up": 928.29998779296875, "invlev_dn": 954.60003662109375, "manhole_up": "manhole_175_generated", "manhole_dn": "manhole_176_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387935.863196024205536, 5855572.491061648353934 ], [ 1387904.610231971368194, 5855611.432584651745856 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1059", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.10003662109375, "elevtn_dn": 947.4000244140625, "invlev_up": 954.60003662109375, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_176_generated", "manhole_dn": "manhole_177_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387904.610231971368194, 5855611.432584651745856 ], [ 1387869.335365027422085, 5855646.852918352000415 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1060", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 947.4000244140625, "invlev_up": 944.9000244140625, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_177_generated", "manhole_dn": "manhole_178_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387869.335365027422085, 5855646.852918352000415 ], [ 1387831.783288773847744, 5855679.735664095729589 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1061", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 947.4000244140625, "invlev_up": 944.9000244140625, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_178_generated", "manhole_dn": "manhole_179_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387831.783288773847744, 5855679.735664095729589 ], [ 1387791.509416193468496, 5855708.923279576934874 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1062", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 933.29998779296875, "invlev_up": 944.9000244140625, "invlev_dn": 930.79998779296875, "manhole_up": "manhole_179_generated", "manhole_dn": "manhole_180_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387791.509416193468496, 5855708.923279576934874 ], [ 1387742.459816947113723, 5855717.213657722808421 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1063", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 933.29998779296875, "elevtn_dn": 933.29998779296875, "invlev_up": 930.79998779296875, "invlev_dn": 930.79998779296875, "manhole_up": "manhole_180_generated", "manhole_dn": "manhole_181_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387742.459816947113723, 5855717.213657722808421 ], [ 1387692.500367184402421, 5855718.495403698645532 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1064", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 933.29998779296875, "elevtn_dn": 911.10003662109375, "invlev_up": 930.79998779296875, "invlev_dn": 908.60003662109375, "manhole_up": "manhole_181_generated", "manhole_dn": "manhole_182_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387692.500367184402421, 5855718.495403698645532 ], [ 1387642.500798417022452, 5855718.61967874225229 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1065", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 911.10003662109375, "elevtn_dn": 887.70001220703125, "invlev_up": 908.60003662109375, "invlev_dn": 885.20001220703125, "manhole_up": "manhole_182_generated", "manhole_dn": "manhole_183_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387642.500798417022452, 5855718.61967874225229 ], [ 1387592.501229649642482, 5855718.743953784927726 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1066", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 887.70001220703125, "elevtn_dn": 887.70001220703125, "invlev_up": 885.20001220703125, "invlev_dn": 885.20001220703125, "manhole_up": "manhole_183_generated", "manhole_dn": "manhole_184_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387592.501229649642482, 5855718.743953784927726 ], [ 1387542.501660882262513, 5855718.868228827603161 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1067", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 887.70001220703125, "elevtn_dn": 902.9000244140625, "invlev_up": 885.20001220703125, "invlev_dn": 900.4000244140625, "manhole_up": "manhole_184_generated", "manhole_dn": "manhole_185_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387542.501660882262513, 5855718.868228827603161 ], [ 1387492.651409652316943, 5855720.815255363471806 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1068", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 902.9000244140625, "elevtn_dn": 902.9000244140625, "invlev_up": 900.4000244140625, "invlev_dn": 900.4000244140625, "manhole_up": "manhole_185_generated", "manhole_dn": "manhole_186_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387492.651409652316943, 5855720.815255363471806 ], [ 1387448.867236748570576, 5855742.752516686916351 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1069", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 902.9000244140625, "elevtn_dn": 886.20001220703125, "invlev_up": 900.4000244140625, "invlev_dn": 883.70001220703125, "manhole_up": "manhole_186_generated", "manhole_dn": "manhole_187_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387448.867236748570576, 5855742.752516686916351 ], [ 1387402.432745414320379, 5855761.091833713464439 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1070", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 886.20001220703125, "elevtn_dn": 886.20001220703125, "invlev_up": 883.70001220703125, "invlev_dn": 883.70001220703125, "manhole_up": "manhole_187_generated", "manhole_dn": "manhole_188_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387402.432745414320379, 5855761.091833713464439 ], [ 1387355.687973388005048, 5855778.837216476909816 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1071", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 886.20001220703125, "elevtn_dn": 879.4000244140625, "invlev_up": 883.70001220703125, "invlev_dn": 876.9000244140625, "manhole_up": "manhole_188_generated", "manhole_dn": "manhole_189_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387355.687973388005048, 5855778.837216476909816 ], [ 1387308.943201361689717, 5855796.582599240355194 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1072", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 879.4000244140625, "elevtn_dn": 879.4000244140625, "invlev_up": 876.9000244140625, "invlev_dn": 876.9000244140625, "manhole_up": "manhole_189_generated", "manhole_dn": "manhole_190_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387308.943201361689717, 5855796.582599240355194 ], [ 1387262.861613623332232, 5855815.656713440082967 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1073", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 879.4000244140625, "elevtn_dn": 873.29998779296875, "invlev_up": 876.9000244140625, "invlev_dn": 870.79998779296875, "manhole_up": "manhole_190_generated", "manhole_dn": "manhole_191_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387262.861613623332232, 5855815.656713440082967 ], [ 1387224.059019178850576, 5855846.996291697025299 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1074", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 873.29998779296875, "elevtn_dn": 938.9000244140625, "invlev_up": 870.79998779296875, "invlev_dn": 936.4000244140625, "manhole_up": "manhole_191_generated", "manhole_dn": "manhole_192_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387224.059019178850576, 5855846.996291697025299 ], [ 1387180.719124856637791, 5855870.194651792757213 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1075", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 938.9000244140625, "elevtn_dn": 932.79998779296875, "invlev_up": 936.4000244140625, "invlev_dn": 930.29998779296875, "manhole_up": "manhole_192_generated", "manhole_dn": "manhole_193_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387180.719124856637791, 5855870.194651792757213 ], [ 1387131.003996425773948, 5855874.064550469629467 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1076", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 932.79998779296875, "elevtn_dn": 932.79998779296875, "invlev_up": 930.29998779296875, "invlev_dn": 930.29998779296875, "manhole_up": "manhole_193_generated", "manhole_dn": "manhole_194_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387131.003996425773948, 5855874.064550469629467 ], [ 1387081.098878284916282, 5855871.158613862469792 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1077", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 932.79998779296875, "elevtn_dn": 916.79998779296875, "invlev_up": 930.29998779296875, "invlev_dn": 914.29998779296875, "manhole_up": "manhole_194_generated", "manhole_dn": "manhole_195_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387081.098878284916282, 5855871.158613862469792 ], [ 1387031.198060098802671, 5855868.015261265449226 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1078", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 916.79998779296875, "elevtn_dn": 916.79998779296875, "invlev_up": 914.29998779296875, "invlev_dn": 914.29998779296875, "manhole_up": "manhole_195_generated", "manhole_dn": "manhole_196_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387031.198060098802671, 5855868.015261265449226 ], [ 1386981.297241912456229, 5855864.871908667497337 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1079", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 916.79998779296875, "elevtn_dn": 891.79998779296875, "invlev_up": 914.29998779296875, "invlev_dn": 889.29998779296875, "manhole_up": "manhole_196_generated", "manhole_dn": "manhole_197_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386981.297241912456229, 5855864.871908667497337 ], [ 1386931.47147326474078, 5855860.718019699677825 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1080", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 891.79998779296875, "elevtn_dn": 891.79998779296875, "invlev_up": 889.29998779296875, "invlev_dn": 889.29998779296875, "manhole_up": "manhole_197_generated", "manhole_dn": "manhole_198_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386931.47147326474078, 5855860.718019699677825 ], [ 1386881.600663758814335, 5855857.577047945931554 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1081", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 891.79998779296875, "elevtn_dn": 857.10003662109375, "invlev_up": 889.29998779296875, "invlev_dn": 854.60003662109375, "manhole_up": "manhole_198_generated", "manhole_dn": "manhole_199_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386881.600663758814335, 5855857.577047945931554 ], [ 1386832.545593914575875, 5855864.100992278195918 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1082", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 857.10003662109375, "elevtn_dn": 857.10003662109375, "invlev_up": 854.60003662109375, "invlev_dn": 854.60003662109375, "manhole_up": "manhole_199_generated", "manhole_dn": "manhole_200_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386832.545593914575875, 5855864.100992278195918 ], [ 1386787.06764860637486, 5855884.403254445642233 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1083", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 857.10003662109375, "elevtn_dn": 821.29998779296875, "invlev_up": 854.60003662109375, "invlev_dn": 818.79998779296875, "manhole_up": "manhole_200_generated", "manhole_dn": "manhole_201_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386787.06764860637486, 5855884.403254445642233 ], [ 1386748.278358669718727, 5855915.544586268253624 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1084", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 821.29998779296875, "elevtn_dn": 821.29998779296875, "invlev_up": 818.79998779296875, "invlev_dn": 818.79998779296875, "manhole_up": "manhole_201_generated", "manhole_dn": "manhole_202_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386748.278358669718727, 5855915.544586268253624 ], [ 1386721.155419877264649, 5855957.124278785660863 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1085", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 821.29998779296875, "elevtn_dn": 866.0, "invlev_up": 818.79998779296875, "invlev_dn": 863.5, "manhole_up": "manhole_202_generated", "manhole_dn": "manhole_203_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386721.155419877264649, 5855957.124278785660863 ], [ 1386707.750365849817172, 5856004.850832763127983 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1086", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 866.0, "invlev_up": 863.5, "invlev_dn": 863.5, "manhole_up": "manhole_203_generated", "manhole_dn": "manhole_204_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386707.750365849817172, 5856004.850832763127983 ], [ 1386699.832475832896307, 5856054.133603978902102 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1087", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 866.0, "invlev_up": 863.5, "invlev_dn": 863.5, "manhole_up": "manhole_204_generated", "manhole_dn": "manhole_205_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386699.832475832896307, 5856054.133603978902102 ], [ 1386697.095561265014112, 5856103.986880083568394 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1088", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 884.79998779296875, "invlev_up": 863.5, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_205_generated", "manhole_dn": "manhole_206_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386697.095561265014112, 5856103.986880083568394 ], [ 1386699.401158998254687, 5856153.933416903018951 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1089", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 884.79998779296875, "invlev_up": 882.29998779296875, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_206_generated", "manhole_dn": "manhole_207_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386699.401158998254687, 5856153.933416903018951 ], [ 1386715.699191288091242, 5856201.197657831013203 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1090", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 884.79998779296875, "invlev_up": 882.29998779296875, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_207_generated", "manhole_dn": "manhole_208_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386715.699191288091242, 5856201.197657831013203 ], [ 1386741.121203816728666, 5856244.100116757676005 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1091", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 915.9000244140625, "invlev_up": 882.29998779296875, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_208_generated", "manhole_dn": "manhole_209_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386741.121203816728666, 5856244.100116757676005 ], [ 1386774.051378605188802, 5856281.577651324681938 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1092", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_209_generated", "manhole_dn": "manhole_210_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386774.051378605188802, 5856281.577651324681938 ], [ 1386811.583791718119755, 5856314.587093180976808 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1093", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_210_generated", "manhole_dn": "manhole_211_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386811.583791718119755, 5856314.587093180976808 ], [ 1386839.378956499742344, 5856356.087350118905306 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1094", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_211_generated", "manhole_dn": "manhole_212_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386839.378956499742344, 5856356.087350118905306 ], [ 1386855.653891535941511, 5856403.364181768149137 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1095", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_212_generated", "manhole_dn": "manhole_213_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386855.653891535941511, 5856403.364181768149137 ], [ 1386875.714553950354457, 5856449.116945925168693 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1096", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_213_generated", "manhole_dn": "manhole_214_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386875.714553950354457, 5856449.116945925168693 ], [ 1386912.179653002182022, 5856482.939191372133791 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1097", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_214_generated", "manhole_dn": "manhole_215_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386912.179653002182022, 5856482.939191372133791 ], [ 1386944.191176384687424, 5856520.270725904032588 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1098", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 911.79998779296875, "invlev_up": 907.4000244140625, "invlev_dn": 909.29998779296875, "manhole_up": "manhole_215_generated", "manhole_dn": "manhole_216_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386944.191176384687424, 5856520.270725904032588 ], [ 1386964.188513180473819, 5856566.025075756013393 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1099", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 911.79998779296875, "elevtn_dn": 911.79998779296875, "invlev_up": 909.29998779296875, "invlev_dn": 909.29998779296875, "manhole_up": "manhole_216_generated", "manhole_dn": "manhole_217_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386964.188513180473819, 5856566.025075756013393 ], [ 1386998.825215350603685, 5856599.261941562406719 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1100", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 911.79998779296875, "elevtn_dn": 932.0, "invlev_up": 909.29998779296875, "invlev_dn": 929.5, "manhole_up": "manhole_217_generated", "manhole_dn": "manhole_218_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386998.825215350603685, 5856599.261941562406719 ], [ 1387044.828526843106374, 5856618.849377661012113 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1101", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 932.0, "invlev_up": 929.5, "invlev_dn": 929.5, "manhole_up": "manhole_218_generated", "manhole_dn": "manhole_219_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387044.828526843106374, 5856618.849377661012113 ], [ 1387090.831838335609064, 5856638.43681376054883 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1102", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 949.9000244140625, "invlev_up": 929.5, "invlev_dn": 947.4000244140625, "manhole_up": "manhole_219_generated", "manhole_dn": "manhole_220_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387090.831838335609064, 5856638.43681376054883 ], [ 1387136.835149827878922, 5856658.024249859154224 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1103", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 949.9000244140625, "elevtn_dn": 924.4000244140625, "invlev_up": 947.4000244140625, "invlev_dn": 921.9000244140625, "manhole_up": "manhole_220_generated", "manhole_dn": "manhole_221_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387136.835149827878922, 5856658.024249859154224 ], [ 1387178.671980312326923, 5856685.128790453076363 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1104", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 924.4000244140625, "elevtn_dn": 924.4000244140625, "invlev_up": 921.9000244140625, "invlev_dn": 921.9000244140625, "manhole_up": "manhole_221_generated", "manhole_dn": "manhole_222_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387178.671980312326923, 5856685.128790453076363 ], [ 1387217.700535611249506, 5856716.320352808572352 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1105", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 924.4000244140625, "elevtn_dn": 940.0, "invlev_up": 921.9000244140625, "invlev_dn": 937.5, "manhole_up": "manhole_222_generated", "manhole_dn": "manhole_223_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387217.700535611249506, 5856716.320352808572352 ], [ 1387252.016686553368345, 5856752.649443434551358 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1106", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 940.0, "elevtn_dn": 940.0, "invlev_up": 937.5, "invlev_dn": 937.5, "manhole_up": "manhole_223_generated", "manhole_dn": "manhole_224_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387252.016686553368345, 5856752.649443434551358 ], [ 1387284.798919493798167, 5856790.190159549936652 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1107", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 940.0, "elevtn_dn": 894.29998779296875, "invlev_up": 937.5, "invlev_dn": 891.79998779296875, "manhole_up": "manhole_224_generated", "manhole_dn": "manhole_225_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387284.798919493798167, 5856790.190159549936652 ], [ 1387273.050185391213745, 5856831.931571422144771 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1108", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 894.29998779296875, "elevtn_dn": 891.5, "invlev_up": 891.79998779296875, "invlev_dn": 889.0, "manhole_up": "manhole_225_generated", "manhole_dn": "manhole_226_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387273.050185391213745, 5856831.931571422144771 ], [ 1387226.106990416301414, 5856849.145192969590425 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1109", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 891.5, "elevtn_dn": 891.5, "invlev_up": 889.0, "invlev_dn": 889.0, "manhole_up": "manhole_226_generated", "manhole_dn": "manhole_227_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387226.106990416301414, 5856849.145192969590425 ], [ 1387179.163795441389084, 5856866.358814516104758 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1110", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 891.5, "elevtn_dn": 881.0, "invlev_up": 889.0, "invlev_dn": 878.5, "manhole_up": "manhole_227_generated", "manhole_dn": "manhole_228_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387179.163795441389084, 5856866.358814516104758 ], [ 1387132.220600466709584, 5856883.572436063550413 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1111", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_228_generated", "manhole_dn": "manhole_229_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387132.220600466709584, 5856883.572436063550413 ], [ 1387091.513159692520276, 5856911.129930667579174 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1112", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_229_generated", "manhole_dn": "manhole_230_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387091.513159692520276, 5856911.129930667579174 ], [ 1387071.007118243258446, 5856956.15559543017298 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1113", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_230_generated", "manhole_dn": "manhole_231_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387071.007118243258446, 5856956.15559543017298 ], [ 1387043.749112035380676, 5856996.689189162105322 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1114", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 856.5, "invlev_up": 878.5, "invlev_dn": 854.0, "manhole_up": "manhole_231_generated", "manhole_dn": "manhole_232_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387043.749112035380676, 5856996.689189162105322 ], [ 1387004.639443967491388, 5857027.840532388538122 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1115", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_232_generated", "manhole_dn": "manhole_233_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387004.639443967491388, 5857027.840532388538122 ], [ 1386965.529775899834931, 5857058.991875615902245 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1116", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_233_generated", "manhole_dn": "manhole_234_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386965.529775899834931, 5857058.991875615902245 ], [ 1386926.702535050921142, 5857090.440239730291069 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1117", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_234_generated", "manhole_dn": "manhole_235_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386926.702535050921142, 5857090.440239730291069 ], [ 1386899.700979894958436, 5857131.871505072340369 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1118", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_235_generated", "manhole_dn": "manhole_236_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386899.700979894958436, 5857131.871505072340369 ], [ 1386903.6263940166682, 5857181.005935152061284 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1119", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 867.29998779296875, "invlev_up": 854.0, "invlev_dn": 864.79998779296875, "manhole_up": "manhole_236_generated", "manhole_dn": "manhole_237_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386903.6263940166682, 5857181.005935152061284 ], [ 1386920.841401966754347, 5857227.85734468139708 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1120", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 867.29998779296875, "elevtn_dn": 867.29998779296875, "invlev_up": 864.79998779296875, "invlev_dn": 864.79998779296875, "manhole_up": "manhole_237_generated", "manhole_dn": "manhole_238_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386920.841401966754347, 5857227.85734468139708 ], [ 1386940.647245415020734, 5857273.767048302106559 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1121", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 867.29998779296875, "elevtn_dn": 879.0, "invlev_up": 864.79998779296875, "invlev_dn": 876.5, "manhole_up": "manhole_238_generated", "manhole_dn": "manhole_239_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386940.647245415020734, 5857273.767048302106559 ], [ 1386960.453088863519952, 5857319.676751921884716 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1122", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 879.0, "elevtn_dn": 884.5, "invlev_up": 876.5, "invlev_dn": 882.0, "manhole_up": "manhole_239_generated", "manhole_dn": "manhole_240_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386960.453088863519952, 5857319.676751921884716 ], [ 1386980.258932311786339, 5857365.586455542594194 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1123", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 884.5, "invlev_up": 882.0, "invlev_dn": 882.0, "manhole_up": "manhole_240_generated", "manhole_dn": "manhole_241_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386980.258932311786339, 5857365.586455542594194 ], [ 1387000.064775760285556, 5857411.496159162372351 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1124", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 884.5, "invlev_up": 882.0, "invlev_dn": 882.0, "manhole_up": "manhole_241_generated", "manhole_dn": "manhole_242_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387000.064775760285556, 5857411.496159162372351 ], [ 1387007.528902114601806, 5857459.537025099620223 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1125", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 893.20001220703125, "invlev_up": 882.0, "invlev_dn": 890.70001220703125, "manhole_up": "manhole_242_generated", "manhole_dn": "manhole_243_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387007.528902114601806, 5857459.537025099620223 ], [ 1386963.21676475298591, 5857476.629049208015203 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1126", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 893.20001220703125, "elevtn_dn": 893.70001220703125, "invlev_up": 890.70001220703125, "invlev_dn": 891.20001220703125, "manhole_up": "manhole_243_generated", "manhole_dn": "manhole_244_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386963.21676475298591, 5857476.629049208015203 ], [ 1386913.783934087026864, 5857484.135433598421514 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1127", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 893.70001220703125, "elevtn_dn": 893.70001220703125, "invlev_up": 891.20001220703125, "invlev_dn": 891.20001220703125, "manhole_up": "manhole_244_generated", "manhole_dn": "manhole_245_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386913.783934087026864, 5857484.135433598421514 ], [ 1386870.539328352315351, 5857507.055611960589886 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1128", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 893.70001220703125, "elevtn_dn": 889.70001220703125, "invlev_up": 891.20001220703125, "invlev_dn": 887.20001220703125, "manhole_up": "manhole_245_generated", "manhole_dn": "manhole_246_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386870.539328352315351, 5857507.055611960589886 ], [ 1386832.820274166297168, 5857539.877026806585491 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1129", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 889.70001220703125, "elevtn_dn": 889.70001220703125, "invlev_up": 887.20001220703125, "invlev_dn": 887.20001220703125, "manhole_up": "manhole_246_generated", "manhole_dn": "manhole_247_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386832.820274166297168, 5857539.877026806585491 ], [ 1386795.101531907683238, 5857572.698800123296678 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1130", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 889.70001220703125, "elevtn_dn": 872.4000244140625, "invlev_up": 887.20001220703125, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_247_generated", "manhole_dn": "manhole_248_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386795.101531907683238, 5857572.698800123296678 ], [ 1386758.257366374600679, 5857606.496797049418092 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1131", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 872.4000244140625, "invlev_up": 869.9000244140625, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_248_generated", "manhole_dn": "manhole_249_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386758.257366374600679, 5857606.496797049418092 ], [ 1386721.502390186069533, 5857640.394349270500243 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1132", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 872.4000244140625, "invlev_up": 869.9000244140625, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_249_generated", "manhole_dn": "manhole_250_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386721.502390186069533, 5857640.394349270500243 ], [ 1386691.639095245627686, 5857680.292891399934888 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1133", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 860.70001220703125, "invlev_up": 869.9000244140625, "invlev_dn": 858.20001220703125, "manhole_up": "manhole_250_generated", "manhole_dn": "manhole_251_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386691.639095245627686, 5857680.292891399934888 ], [ 1386663.127201205352321, 5857721.366519738920033 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1134", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 860.70001220703125, "elevtn_dn": 864.10003662109375, "invlev_up": 858.20001220703125, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_251_generated", "manhole_dn": "manhole_252_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386663.127201205352321, 5857721.366519738920033 ], [ 1386634.70784462057054, 5857762.504245642572641 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1135", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 864.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_252_generated", "manhole_dn": "manhole_253_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386634.70784462057054, 5857762.504245642572641 ], [ 1386606.28848803602159, 5857803.64197154622525 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1136", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 864.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_253_generated", "manhole_dn": "manhole_254_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386606.28848803602159, 5857803.64197154622525 ], [ 1386577.851668093586341, 5857844.766917760483921 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1137", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 836.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 833.60003662109375, "manhole_up": "manhole_254_generated", "manhole_dn": "manhole_255_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386577.851668093586341, 5857844.766917760483921 ], [ 1386559.479123871540651, 5857890.340473555959761 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1138", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 836.10003662109375, "elevtn_dn": 836.10003662109375, "invlev_up": 833.60003662109375, "invlev_dn": 833.60003662109375, "manhole_up": "manhole_255_generated", "manhole_dn": "manhole_256_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386559.479123871540651, 5857890.340473555959761 ], [ 1386576.858566463226452, 5857935.633445805869997 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1139", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 836.10003662109375, "elevtn_dn": 854.9000244140625, "invlev_up": 833.60003662109375, "invlev_dn": 852.4000244140625, "manhole_up": "manhole_256_generated", "manhole_dn": "manhole_257_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386576.858566463226452, 5857935.633445805869997 ], [ 1386619.073707325849682, 5857961.189545376226306 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1140", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 854.9000244140625, "elevtn_dn": 854.9000244140625, "invlev_up": 852.4000244140625, "invlev_dn": 852.4000244140625, "manhole_up": "manhole_257_generated", "manhole_dn": "manhole_258_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386619.073707325849682, 5857961.189545376226306 ], [ 1386664.860782509436831, 5857981.27706332411617 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1141", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 854.9000244140625, "elevtn_dn": 871.60003662109375, "invlev_up": 852.4000244140625, "invlev_dn": 869.10003662109375, "manhole_up": "manhole_258_generated", "manhole_dn": "manhole_259_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386664.860782509436831, 5857981.27706332411617 ], [ 1386710.721602912992239, 5858001.195835201069713 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1142", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 871.60003662109375, "elevtn_dn": 865.10003662109375, "invlev_up": 869.10003662109375, "invlev_dn": 862.60003662109375, "manhole_up": "manhole_259_generated", "manhole_dn": "manhole_260_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386710.721602912992239, 5858001.195835201069713 ], [ 1386756.582423316547647, 5858021.114607078954577 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1143", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 865.10003662109375, "elevtn_dn": 864.70001220703125, "invlev_up": 862.60003662109375, "invlev_dn": 862.20001220703125, "manhole_up": "manhole_260_generated", "manhole_dn": "manhole_261_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386756.582423316547647, 5858021.114607078954577 ], [ 1386802.443243720103055, 5858041.033378956839442 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1144", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 864.70001220703125, "elevtn_dn": 864.70001220703125, "invlev_up": 862.20001220703125, "invlev_dn": 862.20001220703125, "manhole_up": "manhole_261_generated", "manhole_dn": "manhole_262_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386802.443243720103055, 5858041.033378956839442 ], [ 1386848.304064123658463, 5858060.952150834724307 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1145", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 864.70001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 862.20001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_262_generated", "manhole_dn": "manhole_263_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386848.304064123658463, 5858060.952150834724307 ], [ 1386892.843548113014549, 5858083.471454747952521 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1146", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_263_generated", "manhole_dn": "manhole_264_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386892.843548113014549, 5858083.471454747952521 ], [ 1386931.443847785238177, 5858115.251781782135367 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1147", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 853.60003662109375, "invlev_up": 856.70001220703125, "invlev_dn": 851.10003662109375, "manhole_up": "manhole_264_generated", "manhole_dn": "manhole_265_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386931.443847785238177, 5858115.251781782135367 ], [ 1386970.044147457228974, 5858147.032108817249537 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1148", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 853.60003662109375, "elevtn_dn": 853.60003662109375, "invlev_up": 851.10003662109375, "invlev_dn": 851.10003662109375, "manhole_up": "manhole_265_generated", "manhole_dn": "manhole_266_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386970.044147457228974, 5858147.032108817249537 ], [ 1387008.644447129452601, 5858178.812435851432383 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1149", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 853.60003662109375, "elevtn_dn": 842.4000244140625, "invlev_up": 851.10003662109375, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_266_generated", "manhole_dn": "manhole_267_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387008.644447129452601, 5858178.812435851432383 ], [ 1387047.244746801443398, 5858210.592762886546552 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1150", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 842.4000244140625, "invlev_up": 839.9000244140625, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_267_generated", "manhole_dn": "manhole_268_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387047.244746801443398, 5858210.592762886546552 ], [ 1387085.845046473667026, 5858242.373089920729399 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1151", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 842.4000244140625, "invlev_up": 839.9000244140625, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_268_generated", "manhole_dn": "manhole_269_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387085.845046473667026, 5858242.373089920729399 ], [ 1387124.445346145657822, 5858274.153416955843568 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1152", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 827.60003662109375, "invlev_up": 839.9000244140625, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_269_generated", "manhole_dn": "manhole_270_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387124.445346145657822, 5858274.153416955843568 ], [ 1387163.04564581788145, 5858305.933743990026414 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1153", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_270_generated", "manhole_dn": "manhole_271_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387163.04564581788145, 5858305.933743990026414 ], [ 1387201.829349192325026, 5858337.489215047098696 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1154", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 837.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 835.10003662109375, "manhole_up": "manhole_271_generated", "manhole_dn": "manhole_272_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387201.829349192325026, 5858337.489215047098696 ], [ 1387246.200623227981851, 5858359.687651782296598 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1155", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 837.60003662109375, "elevtn_dn": 837.60003662109375, "invlev_up": 835.10003662109375, "invlev_dn": 835.10003662109375, "manhole_up": "manhole_272_generated", "manhole_dn": "manhole_273_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387246.200623227981851, 5858359.687651782296598 ], [ 1387293.201938283629715, 5858376.741938757710159 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1156", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 837.60003662109375, "elevtn_dn": 843.79998779296875, "invlev_up": 835.10003662109375, "invlev_dn": 841.29998779296875, "manhole_up": "manhole_273_generated", "manhole_dn": "manhole_274_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387293.201938283629715, 5858376.741938757710159 ], [ 1387334.200528149493039, 5858401.732468435540795 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1157", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 843.79998779296875, "elevtn_dn": 822.60003662109375, "invlev_up": 841.29998779296875, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_274_generated", "manhole_dn": "manhole_275_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387334.200528149493039, 5858401.732468435540795 ], [ 1387307.843875054037198, 5858437.110805934295058 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1158", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 822.60003662109375, "invlev_up": 820.10003662109375, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_275_generated", "manhole_dn": "manhole_276_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387307.843875054037198, 5858437.110805934295058 ], [ 1387260.279569417703897, 5858425.045736069791019 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1159", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 820.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_276_generated", "manhole_dn": "manhole_277_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387260.279569417703897, 5858425.045736069791019 ], [ 1387211.448235018178821, 5858414.300554806366563 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1160", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_277_generated", "manhole_dn": "manhole_278_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387211.448235018178821, 5858414.300554806366563 ], [ 1387162.612191663123667, 5858403.576134512200952 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1161", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 822.29998779296875, "invlev_up": 825.10003662109375, "invlev_dn": 819.79998779296875, "manhole_up": "manhole_278_generated", "manhole_dn": "manhole_279_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387162.612191663123667, 5858403.576134512200952 ], [ 1387113.700150535441935, 5858393.210482948459685 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1162", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 822.29998779296875, "elevtn_dn": 822.29998779296875, "invlev_up": 819.79998779296875, "invlev_dn": 819.79998779296875, "manhole_up": "manhole_279_generated", "manhole_dn": "manhole_280_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387113.700150535441935, 5858393.210482948459685 ], [ 1387064.993171223672107, 5858381.975642333738506 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1163", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 822.29998779296875, "elevtn_dn": 827.79998779296875, "invlev_up": 819.79998779296875, "invlev_dn": 825.29998779296875, "manhole_up": "manhole_280_generated", "manhole_dn": "manhole_281_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387064.993171223672107, 5858381.975642333738506 ], [ 1387015.796386598376557, 5858376.342007979750633 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1164", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.79998779296875, "elevtn_dn": 827.79998779296875, "invlev_up": 825.29998779296875, "invlev_dn": 825.29998779296875, "manhole_up": "manhole_281_generated", "manhole_dn": "manhole_282_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387015.796386598376557, 5858376.342007979750633 ], [ 1386966.208506174152717, 5858382.746259398758411 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1165", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.79998779296875, "elevtn_dn": 833.9000244140625, "invlev_up": 825.29998779296875, "invlev_dn": 831.4000244140625, "manhole_up": "manhole_282_generated", "manhole_dn": "manhole_283_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386966.208506174152717, 5858382.746259398758411 ], [ 1386916.676812386140227, 5858389.559525708667934 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1166", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 833.9000244140625, "elevtn_dn": 833.9000244140625, "invlev_up": 831.4000244140625, "invlev_dn": 831.4000244140625, "manhole_up": "manhole_283_generated", "manhole_dn": "manhole_284_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386916.676812386140227, 5858389.559525708667934 ], [ 1386867.198860567295924, 5858396.764010772109032 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1167", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 833.9000244140625, "elevtn_dn": 833.20001220703125, "invlev_up": 831.4000244140625, "invlev_dn": 830.70001220703125, "manhole_up": "manhole_284_generated", "manhole_dn": "manhole_285_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386867.198860567295924, 5858396.764010772109032 ], [ 1386820.816385147860274, 5858411.854353901930153 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1168", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 833.20001220703125, "elevtn_dn": 809.60003662109375, "invlev_up": 830.70001220703125, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_285_generated", "manhole_dn": "manhole_286_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386820.816385147860274, 5858411.854353901930153 ], [ 1386841.361234750133008, 5858445.514383808709681 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1169", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 809.79998779296875, "invlev_up": 807.10003662109375, "invlev_dn": 807.29998779296875, "manhole_up": "manhole_286_generated", "manhole_dn": "manhole_287_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386841.361234750133008, 5858445.514383808709681 ], [ 1386890.796275103231892, 5858452.915634987875819 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1170", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.79998779296875, "elevtn_dn": 809.79998779296875, "invlev_up": 807.29998779296875, "invlev_dn": 807.29998779296875, "manhole_up": "manhole_287_generated", "manhole_dn": "manhole_288_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386890.796275103231892, 5858452.915634987875819 ], [ 1386940.277140651131049, 5858460.100081093609333 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1171", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.79998779296875, "elevtn_dn": 805.4000244140625, "invlev_up": 807.29998779296875, "invlev_dn": 802.9000244140625, "manhole_up": "manhole_288_generated", "manhole_dn": "manhole_289_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386940.277140651131049, 5858460.100081093609333 ], [ 1386989.847997799050063, 5858466.483407464809716 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1172", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.4000244140625, "elevtn_dn": 805.4000244140625, "invlev_up": 802.9000244140625, "invlev_dn": 802.9000244140625, "manhole_up": "manhole_289_generated", "manhole_dn": "manhole_290_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386989.847997799050063, 5858466.483407464809716 ], [ 1387039.689648573985323, 5858470.45608530472964 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1173", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.4000244140625, "elevtn_dn": 804.60003662109375, "invlev_up": 802.9000244140625, "invlev_dn": 802.10003662109375, "manhole_up": "manhole_290_generated", "manhole_dn": "manhole_291_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387039.689648573985323, 5858470.45608530472964 ], [ 1387088.843806148739532, 5858479.424946941435337 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1174", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.60003662109375, "elevtn_dn": 809.9000244140625, "invlev_up": 802.10003662109375, "invlev_dn": 807.4000244140625, "manhole_up": "manhole_291_generated", "manhole_dn": "manhole_292_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387088.843806148739532, 5858479.424946941435337 ], [ 1387137.90604472765699, 5858489.061806742101908 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1175", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.9000244140625, "elevtn_dn": 809.9000244140625, "invlev_up": 807.4000244140625, "invlev_dn": 807.4000244140625, "manhole_up": "manhole_292_generated", "manhole_dn": "manhole_293_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387137.90604472765699, 5858489.061806742101908 ], [ 1387186.336529975291342, 5858500.87968063633889 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1176", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.9000244140625, "elevtn_dn": 822.60003662109375, "invlev_up": 807.4000244140625, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_293_generated", "manhole_dn": "manhole_294_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387186.336529975291342, 5858500.87968063633889 ], [ 1387231.661050535272807, 5858521.423059928230941 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1177", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 787.70001220703125, "invlev_up": 820.10003662109375, "invlev_dn": 785.20001220703125, "manhole_up": "manhole_294_generated", "manhole_dn": "manhole_295_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387231.661050535272807, 5858521.423059928230941 ], [ 1387268.120024613803253, 5858555.03504909388721 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1178", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 787.70001220703125, "elevtn_dn": 787.70001220703125, "invlev_up": 785.20001220703125, "invlev_dn": 785.20001220703125, "manhole_up": "manhole_295_generated", "manhole_dn": "manhole_296_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387268.120024613803253, 5858555.03504909388721 ], [ 1387300.917169471969828, 5858592.775208213366568 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1179", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 787.70001220703125, "elevtn_dn": 797.10003662109375, "invlev_up": 785.20001220703125, "invlev_dn": 794.60003662109375, "manhole_up": "manhole_296_generated", "manhole_dn": "manhole_297_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387300.917169471969828, 5858592.775208213366568 ], [ 1387340.521646688459441, 5858622.315198052674532 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1180", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 797.10003662109375, "elevtn_dn": 797.10003662109375, "invlev_up": 794.60003662109375, "invlev_dn": 794.60003662109375, "manhole_up": "manhole_297_generated", "manhole_dn": "manhole_298_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387340.521646688459441, 5858622.315198052674532 ], [ 1387387.476920192595571, 5858639.495844470337033 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1181", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 797.10003662109375, "elevtn_dn": 806.10003662109375, "invlev_up": 794.60003662109375, "invlev_dn": 803.60003662109375, "manhole_up": "manhole_298_generated", "manhole_dn": "manhole_299_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387387.476920192595571, 5858639.495844470337033 ], [ 1387436.116963447071612, 5858650.82861250359565 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1182", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.10003662109375, "elevtn_dn": 806.10003662109375, "invlev_up": 803.60003662109375, "invlev_dn": 803.60003662109375, "manhole_up": "manhole_299_generated", "manhole_dn": "manhole_300_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387436.116963447071612, 5858650.82861250359565 ], [ 1387485.194103535497561, 5858660.261457678861916 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1183", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.10003662109375, "elevtn_dn": 807.70001220703125, "invlev_up": 803.60003662109375, "invlev_dn": 805.20001220703125, "manhole_up": "manhole_300_generated", "manhole_dn": "manhole_301_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387485.194103535497561, 5858660.261457678861916 ], [ 1387533.804190448950976, 5858671.493853995576501 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1184", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.70001220703125, "elevtn_dn": 772.20001220703125, "invlev_up": 805.20001220703125, "invlev_dn": 769.70001220703125, "manhole_up": "manhole_301_generated", "manhole_dn": "manhole_302_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387533.804190448950976, 5858671.493853995576501 ], [ 1387580.2968336828053, 5858689.619015210308135 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1185", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.20001220703125, "elevtn_dn": 778.79998779296875, "invlev_up": 769.70001220703125, "invlev_dn": 776.29998779296875, "manhole_up": "manhole_302_generated", "manhole_dn": "manhole_303_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387580.2968336828053, 5858689.619015210308135 ], [ 1387628.455277157016098, 5858703.062848121859133 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1186", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.79998779296875, "elevtn_dn": 778.79998779296875, "invlev_up": 776.29998779296875, "invlev_dn": 776.29998779296875, "manhole_up": "manhole_303_generated", "manhole_dn": "manhole_304_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387628.455277157016098, 5858703.062848121859133 ], [ 1387677.211432087467983, 5858713.7862489502877 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1187", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.79998779296875, "elevtn_dn": 786.70001220703125, "invlev_up": 776.29998779296875, "invlev_dn": 784.20001220703125, "manhole_up": "manhole_304_generated", "manhole_dn": "manhole_305_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387677.211432087467983, 5858713.7862489502877 ], [ 1387726.995392211945727, 5858712.747126803733408 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1188", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.70001220703125, "elevtn_dn": 786.70001220703125, "invlev_up": 784.20001220703125, "invlev_dn": 784.20001220703125, "manhole_up": "manhole_305_generated", "manhole_dn": "manhole_306_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387726.995392211945727, 5858712.747126803733408 ], [ 1387773.343349169706926, 5858725.014477553777397 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1189", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.70001220703125, "elevtn_dn": 797.70001220703125, "invlev_up": 784.20001220703125, "invlev_dn": 795.20001220703125, "manhole_up": "manhole_306_generated", "manhole_dn": "manhole_307_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387773.343349169706926, 5858725.014477553777397 ], [ 1387806.363672176143155, 5858762.310494473204017 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1190", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 797.70001220703125, "elevtn_dn": 797.70001220703125, "invlev_up": 795.20001220703125, "invlev_dn": 795.20001220703125, "manhole_up": "manhole_307_generated", "manhole_dn": "manhole_308_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387806.363672176143155, 5858762.310494473204017 ], [ 1387799.717027904232964, 5858810.149600365199149 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1191", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 797.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 795.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_308_generated", "manhole_dn": "manhole_309_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387799.717027904232964, 5858810.149600365199149 ], [ 1387771.971139753237367, 5858850.86109375115484 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1192", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_309_generated", "manhole_dn": "manhole_310_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387771.971139753237367, 5858850.86109375115484 ], [ 1387723.07675126590766, 5858854.679317841306329 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1193", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_310_generated", "manhole_dn": "manhole_311_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387723.07675126590766, 5858854.679317841306329 ], [ 1387673.274138238513842, 5858850.996178055182099 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1194", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_311_generated", "manhole_dn": "manhole_312_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387673.274138238513842, 5858850.996178055182099 ], [ 1387624.170362570788711, 5858858.384703231044114 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1195", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_312_generated", "manhole_dn": "manhole_313_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387624.170362570788711, 5858858.384703231044114 ], [ 1387575.715393897145987, 5858857.046076283790171 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1196", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_313_generated", "manhole_dn": "manhole_314_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387575.715393897145987, 5858857.046076283790171 ], [ 1387529.438332577701658, 5858838.116818149574101 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1197", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_314_generated", "manhole_dn": "manhole_315_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387529.438332577701658, 5858838.116818149574101 ], [ 1387481.179235466290265, 5858825.222027675248682 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1198", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_315_generated", "manhole_dn": "manhole_316_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387481.179235466290265, 5858825.222027675248682 ], [ 1387432.215501294471323, 5858815.797906777821481 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1199", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 772.79998779296875, "invlev_up": 774.70001220703125, "invlev_dn": 770.29998779296875, "manhole_up": "manhole_316_generated", "manhole_dn": "manhole_317_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387432.215501294471323, 5858815.797906777821481 ], [ 1387382.431881646160036, 5858811.154251328669488 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1200", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.79998779296875, "elevtn_dn": 747.10003662109375, "invlev_up": 770.29998779296875, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_317_generated", "manhole_dn": "manhole_318_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387382.431881646160036, 5858811.154251328669488 ], [ 1387336.607072548242286, 5858824.075685098767281 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1201", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 747.10003662109375, "invlev_up": 744.60003662109375, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_318_generated", "manhole_dn": "manhole_319_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387336.607072548242286, 5858824.075685098767281 ], [ 1387327.458137275883928, 5858870.88596049696207 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1202", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 747.10003662109375, "invlev_up": 744.60003662109375, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_319_generated", "manhole_dn": "manhole_320_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387327.458137275883928, 5858870.88596049696207 ], [ 1387344.619252334116027, 5858917.848375800997019 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1203", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 773.70001220703125, "invlev_up": 744.60003662109375, "invlev_dn": 771.20001220703125, "manhole_up": "manhole_320_generated", "manhole_dn": "manhole_321_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387344.619252334116027, 5858917.848375800997019 ], [ 1387358.089983508689329, 5858965.710649829357862 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1204", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 773.70001220703125, "elevtn_dn": 773.70001220703125, "invlev_up": 771.20001220703125, "invlev_dn": 771.20001220703125, "manhole_up": "manhole_321_generated", "manhole_dn": "manhole_322_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387358.089983508689329, 5858965.710649829357862 ], [ 1387329.564612702699378, 5859003.583583393134177 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1205", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 773.70001220703125, "elevtn_dn": 774.29998779296875, "invlev_up": 771.20001220703125, "invlev_dn": 771.79998779296875, "manhole_up": "manhole_322_generated", "manhole_dn": "manhole_323_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387329.564612702699378, 5859003.583583393134177 ], [ 1387285.783744251355529, 5858993.703191691078246 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1206", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 774.29998779296875, "elevtn_dn": 774.29998779296875, "invlev_up": 771.79998779296875, "invlev_dn": 771.79998779296875, "manhole_up": "manhole_323_generated", "manhole_dn": "manhole_324_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387285.783744251355529, 5858993.703191691078246 ], [ 1387248.355973182013258, 5858961.31797497626394 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1207", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 774.29998779296875, "elevtn_dn": 769.4000244140625, "invlev_up": 771.79998779296875, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_324_generated", "manhole_dn": "manhole_325_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387248.355973182013258, 5858961.31797497626394 ], [ 1387199.500433639157563, 5858963.645901591517031 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1208", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 769.4000244140625, "invlev_up": 766.9000244140625, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_325_generated", "manhole_dn": "manhole_326_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387199.500433639157563, 5858963.645901591517031 ], [ 1387151.482699199579656, 5858977.583961015567183 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1209", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 762.60003662109375, "invlev_up": 766.9000244140625, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_326_generated", "manhole_dn": "manhole_327_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387151.482699199579656, 5858977.583961015567183 ], [ 1387103.632611613254994, 5858992.082134889438748 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1210", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 762.60003662109375, "invlev_up": 760.10003662109375, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_327_generated", "manhole_dn": "manhole_328_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387103.632611613254994, 5858992.082134889438748 ], [ 1387055.853339510038495, 5859006.816905959509313 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1211", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 755.79998779296875, "invlev_up": 760.10003662109375, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_328_generated", "manhole_dn": "manhole_329_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387055.853339510038495, 5859006.816905959509313 ], [ 1387008.074067406589165, 5859021.551677029579878 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1212", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_329_generated", "manhole_dn": "manhole_330_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387008.074067406589165, 5859021.551677029579878 ], [ 1386960.294795303372666, 5859036.286448099650443 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1213", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 749.5, "invlev_up": 753.29998779296875, "invlev_dn": 747.0, "manhole_up": "manhole_330_generated", "manhole_dn": "manhole_331_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386960.294795303372666, 5859036.286448099650443 ], [ 1386912.515523200156167, 5859051.021219169721007 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1214", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 749.5, "elevtn_dn": 749.5, "invlev_up": 747.0, "invlev_dn": 747.0, "manhole_up": "manhole_331_generated", "manhole_dn": "manhole_332_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386912.515523200156167, 5859051.021219169721007 ], [ 1386864.736251096706837, 5859065.755990239791572 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1215", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 749.5, "elevtn_dn": 727.10003662109375, "invlev_up": 747.0, "invlev_dn": 724.60003662109375, "manhole_up": "manhole_332_generated", "manhole_dn": "manhole_333_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386864.736251096706837, 5859065.755990239791572 ], [ 1386816.956978993490338, 5859080.490761309862137 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1216", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 727.10003662109375, "elevtn_dn": 752.29998779296875, "invlev_up": 724.60003662109375, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_333_generated", "manhole_dn": "manhole_334_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386816.956978993490338, 5859080.490761309862137 ], [ 1386769.832018451532349, 5859096.976014334708452 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1217", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 738.0, "invlev_up": 749.79998779296875, "invlev_dn": 735.5, "manhole_up": "manhole_334_generated", "manhole_dn": "manhole_335_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386769.832018451532349, 5859096.976014334708452 ], [ 1386724.102282747160643, 5859117.193917133845389 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1218", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 738.0, "invlev_up": 735.5, "invlev_dn": 735.5, "manhole_up": "manhole_335_generated", "manhole_dn": "manhole_336_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386724.102282747160643, 5859117.193917133845389 ], [ 1386678.372547042788938, 5859137.411819933913648 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1219", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 732.79998779296875, "invlev_up": 735.5, "invlev_dn": 730.29998779296875, "manhole_up": "manhole_336_generated", "manhole_dn": "manhole_337_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386678.372547042788938, 5859137.411819933913648 ], [ 1386632.642811338417232, 5859157.629722733050585 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1220", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.79998779296875, "elevtn_dn": 732.79998779296875, "invlev_up": 730.29998779296875, "invlev_dn": 730.29998779296875, "manhole_up": "manhole_337_generated", "manhole_dn": "manhole_338_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386632.642811338417232, 5859157.629722733050585 ], [ 1386586.913075634045526, 5859177.847625533118844 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1221", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.79998779296875, "elevtn_dn": 732.60003662109375, "invlev_up": 730.29998779296875, "invlev_dn": 730.10003662109375, "manhole_up": "manhole_338_generated", "manhole_dn": "manhole_339_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386586.913075634045526, 5859177.847625533118844 ], [ 1386541.181931287748739, 5859198.062337793409824 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1222", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.60003662109375, "elevtn_dn": 732.60003662109375, "invlev_up": 730.10003662109375, "invlev_dn": 730.10003662109375, "manhole_up": "manhole_339_generated", "manhole_dn": "manhole_340_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386541.181931287748739, 5859198.062337793409824 ], [ 1386495.431538854492828, 5859218.233453613705933 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1223", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.60003662109375, "elevtn_dn": 742.5, "invlev_up": 730.10003662109375, "invlev_dn": 740.0, "manhole_up": "manhole_340_generated", "manhole_dn": "manhole_341_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386495.431538854492828, 5859218.233453613705933 ], [ 1386449.681146421469748, 5859238.404569433070719 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1224", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 742.5, "invlev_up": 740.0, "invlev_dn": 740.0, "manhole_up": "manhole_341_generated", "manhole_dn": "manhole_342_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386449.681146421469748, 5859238.404569433070719 ], [ 1386404.749107032548636, 5859260.314221715554595 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1225", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 717.60003662109375, "invlev_up": 740.0, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_342_generated", "manhole_dn": "manhole_343_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386404.749107032548636, 5859260.314221715554595 ], [ 1386360.756595908896998, 5859284.020064728334546 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1226", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 717.60003662109375, "invlev_up": 715.10003662109375, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_343_generated", "manhole_dn": "manhole_344_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386360.756595908896998, 5859284.020064728334546 ], [ 1386317.622744857333601, 5859309.307279178872705 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1227", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 711.0, "invlev_up": 715.10003662109375, "invlev_dn": 708.5, "manhole_up": "manhole_344_generated", "manhole_dn": "manhole_345_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386317.622744857333601, 5859309.307279178872705 ], [ 1386274.488893805770203, 5859334.594493629410863 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1228", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 711.0, "elevtn_dn": 717.60003662109375, "invlev_up": 708.5, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_345_generated", "manhole_dn": "manhole_346_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386274.488893805770203, 5859334.594493629410863 ], [ 1386231.354723542230204, 5859359.881163572892547 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1229", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 739.0, "invlev_up": 715.10003662109375, "invlev_dn": 736.5, "manhole_up": "manhole_346_generated", "manhole_dn": "manhole_347_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386231.354723542230204, 5859359.881163572892547 ], [ 1386188.788941488368437, 5859385.978958465158939 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1230", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 739.0, "invlev_up": 736.5, "invlev_dn": 736.5, "manhole_up": "manhole_347_generated", "manhole_dn": "manhole_348_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386188.788941488368437, 5859385.978958465158939 ], [ 1386153.170269979629666, 5859420.751348914578557 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1231", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 739.0, "invlev_up": 736.5, "invlev_dn": 736.5, "manhole_up": "manhole_348_generated", "manhole_dn": "manhole_349_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386153.170269979629666, 5859420.751348914578557 ], [ 1386127.241226618411019, 5859463.08446778729558 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1232", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 770.60003662109375, "invlev_up": 736.5, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_349_generated", "manhole_dn": "manhole_350_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386127.241226618411019, 5859463.08446778729558 ], [ 1386108.996456971857697, 5859509.052053713239729 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1233", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_350_generated", "manhole_dn": "manhole_351_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386108.996456971857697, 5859509.052053713239729 ], [ 1386105.954033384332433, 5859558.959127158857882 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1234", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_351_generated", "manhole_dn": "manhole_352_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386105.954033384332433, 5859558.959127158857882 ], [ 1386101.917093347059563, 5859608.782215913757682 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1235", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 779.79998779296875, "invlev_up": 768.10003662109375, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_352_generated", "manhole_dn": "manhole_353_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386101.917093347059563, 5859608.782215913757682 ], [ 1386088.458339030388743, 5859656.652665913105011 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1236", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 779.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_353_generated", "manhole_dn": "manhole_354_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386088.458339030388743, 5859656.652665913105011 ], [ 1386075.652030121767893, 5859704.419184413738549 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1237", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 779.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_354_generated", "manhole_dn": "manhole_355_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386075.652030121767893, 5859704.419184413738549 ], [ 1386076.574770522769541, 5859754.410392354242504 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1238", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_355_generated", "manhole_dn": "manhole_356_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386076.574770522769541, 5859754.410392354242504 ], [ 1386077.497510923538357, 5859804.401600294746459 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1239", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_356_generated", "manhole_dn": "manhole_357_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386077.497510923538357, 5859804.401600294746459 ], [ 1386078.420251324307173, 5859854.392808235250413 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E195", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 814.29998779296875, "elevtn_dn": 802.9000244140625, "invlev_up": 811.79998779296875, "invlev_dn": 800.4000244140625, "manhole_up": "manhole_358_generated", "manhole_dn": "manhole_359_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384050.267680946970358, 5856698.702001548372209 ], [ 1384085.778961833100766, 5856733.441067186184227 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E196", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 802.9000244140625, "elevtn_dn": 802.9000244140625, "invlev_up": 800.4000244140625, "invlev_dn": 800.4000244140625, "manhole_up": "manhole_359_generated", "manhole_dn": "manhole_360_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384085.778961833100766, 5856733.441067186184227 ], [ 1384122.993944165529683, 5856766.592179889790714 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E197", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 802.9000244140625, "elevtn_dn": 816.29998779296875, "invlev_up": 800.4000244140625, "invlev_dn": 813.79998779296875, "manhole_up": "manhole_360_generated", "manhole_dn": "manhole_361_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384122.993944165529683, 5856766.592179889790714 ], [ 1384160.350959801580757, 5856799.578122235834599 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E198", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.29998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 813.79998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_361_generated", "manhole_dn": "manhole_362_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384160.350959801580757, 5856799.578122235834599 ], [ 1384198.384374253917485, 5856831.724873264320195 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E199", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 798.29998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_362_generated", "manhole_dn": "manhole_363_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384198.384374253917485, 5856831.724873264320195 ], [ 1384230.112839305773377, 5856870.159957353956997 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E200", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 793.9000244140625, "invlev_up": 798.29998779296875, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_363_generated", "manhole_dn": "manhole_364_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384230.112839305773377, 5856870.159957353956997 ], [ 1384259.121702386764809, 5856910.628996902145445 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E201", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 807.60003662109375, "invlev_up": 791.4000244140625, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_364_generated", "manhole_dn": "manhole_365_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384259.121702386764809, 5856910.628996902145445 ], [ 1384287.023718592710793, 5856951.925833041779697 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E202", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_365_generated", "manhole_dn": "manhole_366_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384287.023718592710793, 5856951.925833041779697 ], [ 1384314.929269487503916, 5856993.22028074786067 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E203", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_366_generated", "manhole_dn": "manhole_367_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384314.929269487503916, 5856993.22028074786067 ], [ 1384344.819752591196448, 5857033.056208833120763 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E204", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_367_generated", "manhole_dn": "manhole_368_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384344.819752591196448, 5857033.056208833120763 ], [ 1384375.891110281459987, 5857072.024425559677184 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E205", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_368_generated", "manhole_dn": "manhole_369_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384375.891110281459987, 5857072.024425559677184 ], [ 1384412.732155854580924, 5857105.507668288424611 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E206", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_369_generated", "manhole_dn": "manhole_370_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384412.732155854580924, 5857105.507668288424611 ], [ 1384450.07948348694481, 5857138.509612204506993 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E207", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_370_generated", "manhole_dn": "manhole_371_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384450.07948348694481, 5857138.509612204506993 ], [ 1384487.42686335532926, 5857171.511497005820274 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E208", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 805.0, "invlev_up": 793.4000244140625, "invlev_dn": 802.5, "manhole_up": "manhole_371_generated", "manhole_dn": "manhole_372_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384487.42686335532926, 5857171.511497005820274 ], [ 1384525.207759798038751, 5857204.014277670532465 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E209", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 796.29998779296875, "invlev_up": 802.5, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_372_generated", "manhole_dn": "manhole_373_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384525.207759798038751, 5857204.014277670532465 ], [ 1384563.111988977529109, 5857236.375065575353801 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E210", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 796.29998779296875, "invlev_up": 793.79998779296875, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_373_generated", "manhole_dn": "manhole_374_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384563.111988977529109, 5857236.375065575353801 ], [ 1384601.016218156786636, 5857268.735853480175138 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E211", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 786.10003662109375, "invlev_up": 793.79998779296875, "invlev_dn": 783.60003662109375, "manhole_up": "manhole_374_generated", "manhole_dn": "manhole_375_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384601.016218156786636, 5857268.735853480175138 ], [ 1384638.920447336044163, 5857301.096641384996474 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E212", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.10003662109375, "elevtn_dn": 794.29998779296875, "invlev_up": 783.60003662109375, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_375_generated", "manhole_dn": "manhole_376_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384638.920447336044163, 5857301.096641384996474 ], [ 1384669.604954990325496, 5857340.313404724933207 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E213", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 794.29998779296875, "invlev_up": 791.79998779296875, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_376_generated", "manhole_dn": "manhole_377_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384669.604954990325496, 5857340.313404724933207 ], [ 1384699.518247769214213, 5857380.104403200559318 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E214", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 794.29998779296875, "invlev_up": 791.79998779296875, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_377_generated", "manhole_dn": "manhole_378_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384699.518247769214213, 5857380.104403200559318 ], [ 1384719.806332413339987, 5857425.627417215146124 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E215", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 782.0, "invlev_up": 791.79998779296875, "invlev_dn": 779.5, "manhole_up": "manhole_378_generated", "manhole_dn": "manhole_379_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384719.806332413339987, 5857425.627417215146124 ], [ 1384740.094417057465762, 5857471.150431229732931 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E216", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 782.0, "elevtn_dn": 789.70001220703125, "invlev_up": 779.5, "invlev_dn": 787.20001220703125, "manhole_up": "manhole_379_generated", "manhole_dn": "manhole_380_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384740.094417057465762, 5857471.150431229732931 ], [ 1384760.382501701591536, 5857516.673445244319737 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E217", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 789.70001220703125, "elevtn_dn": 789.70001220703125, "invlev_up": 787.20001220703125, "invlev_dn": 787.20001220703125, "manhole_up": "manhole_380_generated", "manhole_dn": "manhole_381_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384760.382501701591536, 5857516.673445244319737 ], [ 1384780.670586345717311, 5857562.196459258906543 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E218", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 789.70001220703125, "elevtn_dn": 796.5, "invlev_up": 787.20001220703125, "invlev_dn": 794.0, "manhole_up": "manhole_381_generated", "manhole_dn": "manhole_382_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384780.670586345717311, 5857562.196459258906543 ], [ 1384802.672203443944454, 5857606.838341221213341 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E219", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 796.5, "elevtn_dn": 771.9000244140625, "invlev_up": 794.0, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_382_generated", "manhole_dn": "manhole_383_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384802.672203443944454, 5857606.838341221213341 ], [ 1384827.896526007680222, 5857649.823044718243182 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E220", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_383_generated", "manhole_dn": "manhole_384_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384827.896526007680222, 5857649.823044718243182 ], [ 1384854.757882944308221, 5857691.606820800341666 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E221", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_384_generated", "manhole_dn": "manhole_385_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384854.757882944308221, 5857691.606820800341666 ], [ 1384888.185768931638449, 5857728.573395187035203 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E222", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_385_generated", "manhole_dn": "manhole_386_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384888.185768931638449, 5857728.573395187035203 ], [ 1384921.613654918735847, 5857765.539969574660063 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E223", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 755.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_386_generated", "manhole_dn": "manhole_387_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384921.613654918735847, 5857765.539969574660063 ], [ 1384956.145453942706808, 5857801.445756647735834 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E224", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 755.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_387_generated", "manhole_dn": "manhole_388_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384956.145453942706808, 5857801.445756647735834 ], [ 1384991.751306539867073, 5857836.319449373520911 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E225", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 746.0, "invlev_up": 755.4000244140625, "invlev_dn": 743.5, "manhole_up": "manhole_388_generated", "manhole_dn": "manhole_389_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384991.751306539867073, 5857836.319449373520911 ], [ 1385027.357159137027338, 5857871.193142099305987 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E226", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 746.0, "elevtn_dn": 755.79998779296875, "invlev_up": 743.5, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_389_generated", "manhole_dn": "manhole_390_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385027.357159137027338, 5857871.193142099305987 ], [ 1385062.963011734187603, 5857906.066834825091064 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E227", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 728.60003662109375, "invlev_up": 753.29998779296875, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_390_generated", "manhole_dn": "manhole_391_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385062.963011734187603, 5857906.066834825091064 ], [ 1385098.568864331347868, 5857940.940527551807463 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E228", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 728.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_391_generated", "manhole_dn": "manhole_392_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385098.568864331347868, 5857940.940527551807463 ], [ 1385135.753846400883049, 5857974.029479116201401 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E229", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 728.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_392_generated", "manhole_dn": "manhole_393_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385135.753846400883049, 5857974.029479116201401 ], [ 1385175.738456205930561, 5858003.622975903563201 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E230", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 735.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 733.10003662109375, "manhole_up": "manhole_393_generated", "manhole_dn": "manhole_394_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385175.738456205930561, 5858003.622975903563201 ], [ 1385218.653756857383996, 5858028.965196672827005 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E231", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 735.60003662109375, "elevtn_dn": 735.60003662109375, "invlev_up": 733.10003662109375, "invlev_dn": 733.10003662109375, "manhole_up": "manhole_394_generated", "manhole_dn": "manhole_395_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385218.653756857383996, 5858028.965196672827005 ], [ 1385262.454936756985262, 5858052.706982978619635 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E232", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 735.60003662109375, "elevtn_dn": 742.0, "invlev_up": 733.10003662109375, "invlev_dn": 739.5, "manhole_up": "manhole_395_generated", "manhole_dn": "manhole_396_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385262.454936756985262, 5858052.706982978619635 ], [ 1385306.715555034345016, 5858075.618745312094688 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E233", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 742.0, "elevtn_dn": 742.0, "invlev_up": 739.5, "invlev_dn": 739.5, "manhole_up": "manhole_396_generated", "manhole_dn": "manhole_397_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385306.715555034345016, 5858075.618745312094688 ], [ 1385350.97617331170477, 5858098.530507644638419 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E234", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 742.0, "elevtn_dn": 736.0, "invlev_up": 739.5, "invlev_dn": 733.5, "manhole_up": "manhole_397_generated", "manhole_dn": "manhole_398_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385350.97617331170477, 5858098.530507644638419 ], [ 1385395.236791589297354, 5858121.442269978113472 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E235", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 736.0, "elevtn_dn": 736.0, "invlev_up": 733.5, "invlev_dn": 733.5, "manhole_up": "manhole_398_generated", "manhole_dn": "manhole_399_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385395.236791589297354, 5858121.442269978113472 ], [ 1385439.497409866657108, 5858144.354032310657203 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E236", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 736.0, "elevtn_dn": 737.9000244140625, "invlev_up": 733.5, "invlev_dn": 735.4000244140625, "manhole_up": "manhole_399_generated", "manhole_dn": "manhole_400_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385439.497409866657108, 5858144.354032310657203 ], [ 1385483.758028144016862, 5858167.265794644132257 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E237", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.9000244140625, "elevtn_dn": 737.9000244140625, "invlev_up": 735.4000244140625, "invlev_dn": 735.4000244140625, "manhole_up": "manhole_400_generated", "manhole_dn": "manhole_401_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385483.758028144016862, 5858167.265794644132257 ], [ 1385528.018646421376616, 5858190.17755697760731 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E238", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.9000244140625, "elevtn_dn": 727.29998779296875, "invlev_up": 735.4000244140625, "invlev_dn": 724.79998779296875, "manhole_up": "manhole_401_generated", "manhole_dn": "manhole_402_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385528.018646421376616, 5858190.17755697760731 ], [ 1385571.606102279853076, 5858214.277655217796564 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E239", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 727.29998779296875, "elevtn_dn": 727.29998779296875, "invlev_up": 724.79998779296875, "invlev_dn": 724.79998779296875, "manhole_up": "manhole_402_generated", "manhole_dn": "manhole_403_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385571.606102279853076, 5858214.277655217796564 ], [ 1385614.013400863157585, 5858240.461089110001922 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E240", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 727.29998779296875, "elevtn_dn": 690.60003662109375, "invlev_up": 724.79998779296875, "invlev_dn": 688.10003662109375, "manhole_up": "manhole_403_generated", "manhole_dn": "manhole_404_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385614.013400863157585, 5858240.461089110001922 ], [ 1385656.420699446462095, 5858266.644523002207279 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E241", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 690.60003662109375, "elevtn_dn": 733.60003662109375, "invlev_up": 688.10003662109375, "invlev_dn": 731.10003662109375, "manhole_up": "manhole_404_generated", "manhole_dn": "manhole_405_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385656.420699446462095, 5858266.644523002207279 ], [ 1385698.773111530812457, 5858292.8961898451671 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E242", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 733.60003662109375, "elevtn_dn": 733.60003662109375, "invlev_up": 731.10003662109375, "invlev_dn": 731.10003662109375, "manhole_up": "manhole_405_generated", "manhole_dn": "manhole_406_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385698.773111530812457, 5858292.8961898451671 ], [ 1385733.435650466475636, 5858328.707634637132287 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E243", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 733.60003662109375, "elevtn_dn": 721.60003662109375, "invlev_up": 731.10003662109375, "invlev_dn": 719.10003662109375, "manhole_up": "manhole_406_generated", "manhole_dn": "manhole_407_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385733.435650466475636, 5858328.707634637132287 ], [ 1385768.098189401905984, 5858364.519079428166151 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E244", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 721.60003662109375, "elevtn_dn": 721.60003662109375, "invlev_up": 719.10003662109375, "invlev_dn": 719.10003662109375, "manhole_up": "manhole_407_generated", "manhole_dn": "manhole_408_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385768.098189401905984, 5858364.519079428166151 ], [ 1385795.882535298354924, 5858405.467093757353723 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E245", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 721.60003662109375, "elevtn_dn": 739.0, "invlev_up": 719.10003662109375, "invlev_dn": 736.5, "manhole_up": "manhole_408_generated", "manhole_dn": "manhole_409_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385795.882535298354924, 5858405.467093757353723 ], [ 1385820.377634756267071, 5858448.871486231684685 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E246", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 727.79998779296875, "invlev_up": 736.5, "invlev_dn": 725.29998779296875, "manhole_up": "manhole_409_generated", "manhole_dn": "manhole_410_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385820.377634756267071, 5858448.871486231684685 ], [ 1385841.084314390551299, 5858493.920932004228234 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E247", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 727.79998779296875, "elevtn_dn": 727.79998779296875, "invlev_up": 725.29998779296875, "invlev_dn": 725.29998779296875, "manhole_up": "manhole_410_generated", "manhole_dn": "manhole_411_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385841.084314390551299, 5858493.920932004228234 ], [ 1385856.076261736918241, 5858541.451897682622075 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E248", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 727.79998779296875, "elevtn_dn": 734.9000244140625, "invlev_up": 725.29998779296875, "invlev_dn": 732.4000244140625, "manhole_up": "manhole_411_generated", "manhole_dn": "manhole_412_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385856.076261736918241, 5858541.451897682622075 ], [ 1385865.668899663724005, 5858590.250006795860827 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E249", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 734.9000244140625, "elevtn_dn": 734.9000244140625, "invlev_up": 732.4000244140625, "invlev_dn": 732.4000244140625, "manhole_up": "manhole_412_generated", "manhole_dn": "manhole_413_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385865.668899663724005, 5858590.250006795860827 ], [ 1385873.387286560609937, 5858639.487976770848036 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E250", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 734.9000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 732.4000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_413_generated", "manhole_dn": "manhole_414_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385873.387286560609937, 5858639.487976770848036 ], [ 1385875.017949819331989, 5858689.287253175862134 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E251", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 748.9000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_414_generated", "manhole_dn": "manhole_415_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385875.017949819331989, 5858689.287253175862134 ], [ 1385876.432928551919758, 5858739.106416343711317 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E252", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 748.9000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_415_generated", "manhole_dn": "manhole_416_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385876.432928551919758, 5858739.106416343711317 ], [ 1385878.329821793129668, 5858788.908141564577818 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E253", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 748.9000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_416_generated", "manhole_dn": "manhole_417_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385878.329821793129668, 5858788.908141564577818 ], [ 1385880.51921496167779, 5858838.69928275514394 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E254", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_417_generated", "manhole_dn": "manhole_418_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385880.51921496167779, 5858838.69928275514394 ], [ 1385882.620351102668792, 5858888.493530485779047 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E255", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_418_generated", "manhole_dn": "manhole_419_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385882.620351102668792, 5858888.493530485779047 ], [ 1385883.937443709466606, 5858938.315377607010305 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E256", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 766.10003662109375, "invlev_up": 757.20001220703125, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_419_generated", "manhole_dn": "manhole_420_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385883.937443709466606, 5858938.315377607010305 ], [ 1385885.254538560518995, 5858988.137224668636918 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E257", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 766.10003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_420_generated", "manhole_dn": "manhole_421_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385885.254538560518995, 5858988.137224668636918 ], [ 1385890.650534195825458, 5859037.630400610156357 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E258", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 766.10003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_421_generated", "manhole_dn": "manhole_422_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385890.650534195825458, 5859037.630400610156357 ], [ 1385901.777442803606391, 5859086.09239396546036 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E259", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 768.60003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 766.10003662109375, "manhole_up": "manhole_422_generated", "manhole_dn": "manhole_423_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385901.777442803606391, 5859086.09239396546036 ], [ 1385915.397954803425819, 5859134.03436760418117 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E260", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.60003662109375, "elevtn_dn": 762.79998779296875, "invlev_up": 766.10003662109375, "invlev_dn": 760.29998779296875, "manhole_up": "manhole_423_generated", "manhole_dn": "manhole_424_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385915.397954803425819, 5859134.03436760418117 ], [ 1385928.42605347908102, 5859182.139209139160812 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E261", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.79998779296875, "elevtn_dn": 762.5, "invlev_up": 760.29998779296875, "invlev_dn": 760.0, "manhole_up": "manhole_424_generated", "manhole_dn": "manhole_425_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385928.42605347908102, 5859182.139209139160812 ], [ 1385941.228082312969491, 5859230.306202415376902 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E262", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 762.5, "invlev_up": 760.0, "invlev_dn": 760.0, "manhole_up": "manhole_425_generated", "manhole_dn": "manhole_426_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385941.228082312969491, 5859230.306202415376902 ], [ 1385945.092689140234143, 5859279.734331246465445 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E263", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 762.5, "invlev_up": 760.0, "invlev_dn": 760.0, "manhole_up": "manhole_426_generated", "manhole_dn": "manhole_427_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385945.092689140234143, 5859279.734331246465445 ], [ 1385937.902412303024903, 5859328.779896341264248 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E264", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 778.0, "invlev_up": 760.0, "invlev_dn": 775.5, "manhole_up": "manhole_427_generated", "manhole_dn": "manhole_428_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.902412303024903, 5859328.779896341264248 ], [ 1385932.795075723901391, 5859378.173214216716588 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E265", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 778.0, "invlev_up": 775.5, "invlev_dn": 775.5, "manhole_up": "manhole_428_generated", "manhole_dn": "manhole_429_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385932.795075723901391, 5859378.173214216716588 ], [ 1385937.702695531537756, 5859427.770254967734218 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E266", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 778.0, "invlev_up": 775.5, "invlev_dn": 775.5, "manhole_up": "manhole_429_generated", "manhole_dn": "manhole_430_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.702695531537756, 5859427.770254967734218 ], [ 1385939.035937832202762, 5859477.50230407807976 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E267", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 795.9000244140625, "invlev_up": 775.5, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_430_generated", "manhole_dn": "manhole_431_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385939.035937832202762, 5859477.50230407807976 ], [ 1385937.883638251805678, 5859527.328234969638288 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E268", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_431_generated", "manhole_dn": "manhole_432_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.883638251805678, 5859527.328234969638288 ], [ 1385940.515994266141206, 5859576.989168248139322 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E269", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_432_generated", "manhole_dn": "manhole_433_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385940.515994266141206, 5859576.989168248139322 ], [ 1385950.701545101590455, 5859625.530176519416273 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E270", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 815.0, "invlev_up": 793.4000244140625, "invlev_dn": 812.5, "manhole_up": "manhole_433_generated", "manhole_dn": "manhole_434_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385950.701545101590455, 5859625.530176519416273 ], [ 1385970.467743494315073, 5859670.991298755630851 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E271", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 815.0, "elevtn_dn": 815.0, "invlev_up": 812.5, "invlev_dn": 812.5, "manhole_up": "manhole_434_generated", "manhole_dn": "manhole_435_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385970.467743494315073, 5859670.991298755630851 ], [ 1386011.983088220236823, 5859697.862916950136423 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E272", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 815.0, "elevtn_dn": 779.79998779296875, "invlev_up": 812.5, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_435_generated", "manhole_dn": "manhole_436_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386011.983088220236823, 5859697.862916950136423 ], [ 1386052.213596233632416, 5859727.119808158837259 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E273", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_436_generated", "manhole_dn": "manhole_437_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386052.213596233632416, 5859727.119808158837259 ], [ 1386046.501012831227854, 5859771.612671964801848 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E274", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_437_generated", "manhole_dn": "manhole_438_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386046.501012831227854, 5859771.612671964801848 ], [ 1386026.809695787727833, 5859816.873920152895153 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E275", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_438_generated", "manhole_dn": "manhole_439_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386026.809695787727833, 5859816.873920152895153 ], [ 1386030.149607364553958, 5859866.379009906202555 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E276", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_439_generated", "manhole_dn": "manhole_440_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386030.149607364553958, 5859866.379009906202555 ], [ 1386045.250939248362556, 5859913.859036295674741 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_11_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 798.29998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_441_generated", "manhole_dn": "manhole_442_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384196.861816460033879, 5856829.88048410974443 ], [ 1384235.22519311751239, 5856854.977665597572923 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_11_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 793.9000244140625, "invlev_up": 798.29998779296875, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_442_generated", "manhole_dn": "manhole_443_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384235.22519311751239, 5856854.977665597572923 ], [ 1384263.450329831801355, 5856892.038370934315026 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_11_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 793.9000244140625, "invlev_up": 791.4000244140625, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_443_generated", "manhole_dn": "manhole_444_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384263.450329831801355, 5856892.038370934315026 ], [ 1384291.675466545857489, 5856929.099076271057129 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_11_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 807.60003662109375, "invlev_up": 791.4000244140625, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_444_generated", "manhole_dn": "manhole_445_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384291.675466545857489, 5856929.099076271057129 ], [ 1384319.900603260146454, 5856966.159781608730555 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_11_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_445_generated", "manhole_dn": "manhole_446_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384319.900603260146454, 5856966.159781608730555 ], [ 1384347.205867683747783, 5857003.894510924816132 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_11_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 799.0, "invlev_up": 805.10003662109375, "invlev_dn": 796.5, "manhole_up": "manhole_446_generated", "manhole_dn": "manhole_447_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384347.205867683747783, 5857003.894510924816132 ], [ 1384380.322691001230851, 5857036.360282040201128 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_11_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 799.0, "elevtn_dn": 807.60003662109375, "invlev_up": 796.5, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_447_generated", "manhole_dn": "manhole_448_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384380.322691001230851, 5857036.360282040201128 ], [ 1384415.156610523350537, 5857067.291694445535541 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_11_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_448_generated", "manhole_dn": "manhole_449_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384415.156610523350537, 5857067.291694445535541 ], [ 1384449.343575850594789, 5857098.828100205399096 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_11_E8", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_449_generated", "manhole_dn": "manhole_450_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384449.343575850594789, 5857098.828100205399096 ], [ 1384470.004810179118067, 5857139.926174183376133 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_11_E9", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_450_generated", "manhole_dn": "manhole_451_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384470.004810179118067, 5857139.926174183376133 ], [ 1384484.18076178082265, 5857184.301805094815791 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_12_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_452_generated", "manhole_dn": "manhole_453_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384289.06552429520525, 5856954.947841017507017 ], [ 1384305.049610810354352, 5856994.88734863139689 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_12_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_453_generated", "manhole_dn": "manhole_454_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384305.049610810354352, 5856994.88734863139689 ], [ 1384321.033697325503454, 5857034.82685624435544 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_12_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 799.0, "invlev_up": 805.10003662109375, "invlev_dn": 796.5, "manhole_up": "manhole_454_generated", "manhole_dn": "manhole_455_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384321.033697325503454, 5857034.82685624435544 ], [ 1384347.445656489115208, 5857068.672038841992617 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_12_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 799.0, "elevtn_dn": 807.60003662109375, "invlev_up": 796.5, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_455_generated", "manhole_dn": "manhole_456_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384347.445656489115208, 5857068.672038841992617 ], [ 1384374.130628447979689, 5857102.406951548531651 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_12_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_456_generated", "manhole_dn": "manhole_457_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384374.130628447979689, 5857102.406951548531651 ], [ 1384399.587644136510789, 5857137.08541233278811 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_12_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_457_generated", "manhole_dn": "manhole_458_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384399.587644136510789, 5857137.08541233278811 ], [ 1384425.04465982504189, 5857171.763873117044568 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_12_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_458_generated", "manhole_dn": "manhole_459_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384425.04465982504189, 5857171.763873117044568 ], [ 1384456.866520966170356, 5857200.577977900393307 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_15_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_15", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_15", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_459_generated", "manhole_dn": "manhole_460_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384456.866520966170356, 5857200.577977900393307 ], [ 1384480.774830641923472, 5857195.244455400854349 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_17_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_17", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_17", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 805.0, "invlev_up": 793.4000244140625, "invlev_dn": 802.5, "manhole_up": "manhole_459_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384456.866520966170356, 5857200.577977900393307 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_18_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_18", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_18", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_462_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384493.329776774393395, 5857201.952337642200291 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_19_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_19", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_19", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_462_generated", "manhole_dn": "manhole_463_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384493.329776774393395, 5857201.952337642200291 ], [ 1384511.321100181667134, 5857246.008046119473875 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_19_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_19", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_19", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_463_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384511.321100181667134, 5857246.008046119473875 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 796.29998779296875, "invlev_up": 802.5, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_464_generated", "manhole_dn": "manhole_465_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384512.484966830350459, 5857248.858029337599874 ], [ 1384550.208547196350992, 5857281.609186780638993 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 796.29998779296875, "invlev_up": 793.79998779296875, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_465_generated", "manhole_dn": "manhole_466_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384550.208547196350992, 5857281.609186780638993 ], [ 1384587.932127562351525, 5857314.360344224609435 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 809.10003662109375, "invlev_up": 793.79998779296875, "invlev_dn": 806.60003662109375, "manhole_up": "manhole_466_generated", "manhole_dn": "manhole_467_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384587.932127562351525, 5857314.360344224609435 ], [ 1384608.456866907887161, 5857358.785165345296264 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.10003662109375, "elevtn_dn": 809.10003662109375, "invlev_up": 806.60003662109375, "invlev_dn": 806.60003662109375, "manhole_up": "manhole_467_generated", "manhole_dn": "manhole_468_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384608.456866907887161, 5857358.785165345296264 ], [ 1384624.966163935838267, 5857405.935456342995167 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.10003662109375, "elevtn_dn": 794.29998779296875, "invlev_up": 806.60003662109375, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_468_generated", "manhole_dn": "manhole_469_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384624.966163935838267, 5857405.935456342995167 ], [ 1384639.938245237572119, 5857453.586039477027953 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 812.4000244140625, "invlev_up": 791.79998779296875, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_469_generated", "manhole_dn": "manhole_470_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384639.938245237572119, 5857453.586039477027953 ], [ 1384654.3423755497206, 5857501.421464210376143 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 812.4000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_470_generated", "manhole_dn": "manhole_471_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384654.3423755497206, 5857501.421464210376143 ], [ 1384665.748858094681054, 5857550.055336253717542 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 812.4000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_471_generated", "manhole_dn": "manhole_472_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384665.748858094681054, 5857550.055336253717542 ], [ 1384677.04772660904564, 5857598.717872150242329 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E8", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 818.9000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 816.4000244140625, "manhole_up": "manhole_472_generated", "manhole_dn": "manhole_473_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384677.04772660904564, 5857598.717872150242329 ], [ 1384688.346595123410225, 5857647.380408045835793 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E9", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 818.9000244140625, "elevtn_dn": 818.9000244140625, "invlev_up": 816.4000244140625, "invlev_dn": 816.4000244140625, "manhole_up": "manhole_473_generated", "manhole_dn": "manhole_474_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384688.346595123410225, 5857647.380408045835793 ], [ 1384699.64546363777481, 5857696.042943941429257 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E10", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 818.9000244140625, "elevtn_dn": 791.0, "invlev_up": 816.4000244140625, "invlev_dn": 788.5, "manhole_up": "manhole_474_generated", "manhole_dn": "manhole_475_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384699.64546363777481, 5857696.042943941429257 ], [ 1384710.944332152139395, 5857744.705479837954044 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E11", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 771.9000244140625, "invlev_up": 788.5, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_475_generated", "manhole_dn": "manhole_476_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384710.944332152139395, 5857744.705479837954044 ], [ 1384726.848783193388954, 5857791.671307560056448 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E12", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_476_generated", "manhole_dn": "manhole_477_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384726.848783193388954, 5857791.671307560056448 ], [ 1384753.929338480113074, 5857833.199649352580309 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E13", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_477_generated", "manhole_dn": "manhole_478_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384753.929338480113074, 5857833.199649352580309 ], [ 1384783.627482200739905, 5857873.006575288251042 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E14", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 791.0, "invlev_up": 769.4000244140625, "invlev_dn": 788.5, "manhole_up": "manhole_478_generated", "manhole_dn": "manhole_479_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384783.627482200739905, 5857873.006575288251042 ], [ 1384795.018452654592693, 5857920.637507135979831 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E15", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 791.0, "invlev_up": 788.5, "invlev_dn": 788.5, "manhole_up": "manhole_479_generated", "manhole_dn": "manhole_480_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384795.018452654592693, 5857920.637507135979831 ], [ 1384785.075932276435196, 5857969.445633230730891 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E16", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 820.10003662109375, "invlev_up": 788.5, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_480_generated", "manhole_dn": "manhole_481_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384785.075932276435196, 5857969.445633230730891 ], [ 1384771.479073295136914, 5858017.516749874688685 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E17", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 820.10003662109375, "invlev_up": 817.60003662109375, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_481_generated", "manhole_dn": "manhole_482_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384771.479073295136914, 5858017.516749874688685 ], [ 1384763.32518996251747, 5858066.675425447523594 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E18", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 820.10003662109375, "invlev_up": 817.60003662109375, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_482_generated", "manhole_dn": "manhole_483_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384763.32518996251747, 5858066.675425447523594 ], [ 1384757.405406558187678, 5858116.280495692044497 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E19", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 847.0, "invlev_up": 817.60003662109375, "invlev_dn": 844.5, "manhole_up": "manhole_483_generated", "manhole_dn": "manhole_484_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384757.405406558187678, 5858116.280495692044497 ], [ 1384746.211964494548738, 5858164.956996791996062 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E20", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 847.0, "invlev_up": 844.5, "invlev_dn": 844.5, "manhole_up": "manhole_484_generated", "manhole_dn": "manhole_485_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384746.211964494548738, 5858164.956996791996062 ], [ 1384738.028054837835953, 5858213.862443570047617 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E21", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 847.0, "invlev_up": 844.5, "invlev_dn": 844.5, "manhole_up": "manhole_485_generated", "manhole_dn": "manhole_486_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384738.028054837835953, 5858213.862443570047617 ], [ 1384756.479259133106098, 5858259.218586039729416 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E22", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 833.20001220703125, "invlev_up": 844.5, "invlev_dn": 830.70001220703125, "manhole_up": "manhole_486_generated", "manhole_dn": "manhole_487_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384756.479259133106098, 5858259.218586039729416 ], [ 1384792.653981153853238, 5858293.25339647103101 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E23", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 833.20001220703125, "elevtn_dn": 762.29998779296875, "invlev_up": 830.70001220703125, "invlev_dn": 759.79998779296875, "manhole_up": "manhole_487_generated", "manhole_dn": "manhole_488_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384792.653981153853238, 5858293.25339647103101 ], [ 1384839.146884107263759, 5858310.949097327888012 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E24", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.29998779296875, "elevtn_dn": 762.29998779296875, "invlev_up": 759.79998779296875, "invlev_dn": 759.79998779296875, "manhole_up": "manhole_488_generated", "manhole_dn": "manhole_489_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384839.146884107263759, 5858310.949097327888012 ], [ 1384888.517509665805846, 5858307.535864246077836 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E25", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.29998779296875, "elevtn_dn": 751.0, "invlev_up": 759.79998779296875, "invlev_dn": 748.5, "manhole_up": "manhole_489_generated", "manhole_dn": "manhole_490_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384888.517509665805846, 5858307.535864246077836 ], [ 1384936.622762819286436, 5858294.068231076002121 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E26", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.0, "elevtn_dn": 751.0, "invlev_up": 748.5, "invlev_dn": 748.5, "manhole_up": "manhole_490_generated", "manhole_dn": "manhole_491_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384936.622762819286436, 5858294.068231076002121 ], [ 1384984.637113286415115, 5858280.272530450485647 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E27", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.0, "elevtn_dn": 743.20001220703125, "invlev_up": 748.5, "invlev_dn": 740.70001220703125, "manhole_up": "manhole_491_generated", "manhole_dn": "manhole_492_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384984.637113286415115, 5858280.272530450485647 ], [ 1385032.633651287527755, 5858266.414710656739771 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E28", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 743.20001220703125, "elevtn_dn": 743.20001220703125, "invlev_up": 740.70001220703125, "invlev_dn": 740.70001220703125, "manhole_up": "manhole_492_generated", "manhole_dn": "manhole_493_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385032.633651287527755, 5858266.414710656739771 ], [ 1385081.886840383987874, 5858258.136644747108221 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E29", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 743.20001220703125, "elevtn_dn": 747.60003662109375, "invlev_up": 740.70001220703125, "invlev_dn": 745.10003662109375, "manhole_up": "manhole_493_generated", "manhole_dn": "manhole_494_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385081.886840383987874, 5858258.136644747108221 ], [ 1385131.310463621048257, 5858263.211211345158517 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E30", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.60003662109375, "elevtn_dn": 756.79998779296875, "invlev_up": 745.10003662109375, "invlev_dn": 754.29998779296875, "manhole_up": "manhole_494_generated", "manhole_dn": "manhole_495_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385131.310463621048257, 5858263.211211345158517 ], [ 1385177.729395114118233, 5858281.168494092300534 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E31", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.79998779296875, "elevtn_dn": 758.9000244140625, "invlev_up": 754.29998779296875, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_495_generated", "manhole_dn": "manhole_496_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385177.729395114118233, 5858281.168494092300534 ], [ 1385219.95651927171275, 5858307.84242575801909 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E32", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 758.9000244140625, "invlev_up": 756.4000244140625, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_496_generated", "manhole_dn": "manhole_497_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385219.95651927171275, 5858307.84242575801909 ], [ 1385261.864506913116202, 5858335.034840167500079 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E33", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 756.29998779296875, "invlev_up": 756.4000244140625, "invlev_dn": 753.79998779296875, "manhole_up": "manhole_497_generated", "manhole_dn": "manhole_498_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385261.864506913116202, 5858335.034840167500079 ], [ 1385305.658712412696332, 5858358.964500648900867 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E34", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 756.29998779296875, "invlev_up": 753.79998779296875, "invlev_dn": 753.79998779296875, "manhole_up": "manhole_498_generated", "manhole_dn": "manhole_499_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385305.658712412696332, 5858358.964500648900867 ], [ 1385350.136275847908109, 5858381.712097893469036 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E35", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 750.79998779296875, "invlev_up": 753.79998779296875, "invlev_dn": 748.29998779296875, "manhole_up": "manhole_499_generated", "manhole_dn": "manhole_500_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385350.136275847908109, 5858381.712097893469036 ], [ 1385394.617425152566284, 5858404.452682325616479 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E36", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 750.79998779296875, "elevtn_dn": 760.20001220703125, "invlev_up": 748.29998779296875, "invlev_dn": 757.70001220703125, "manhole_up": "manhole_500_generated", "manhole_dn": "manhole_501_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385394.617425152566284, 5858404.452682325616479 ], [ 1385439.245915542822331, 5858426.901898948475718 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E37", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 760.20001220703125, "elevtn_dn": 754.29998779296875, "invlev_up": 757.70001220703125, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_501_generated", "manhole_dn": "manhole_502_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385439.245915542822331, 5858426.901898948475718 ], [ 1385483.926139793125913, 5858449.248809035867453 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E38", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 754.29998779296875, "invlev_up": 751.79998779296875, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_502_generated", "manhole_dn": "manhole_503_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385483.926139793125913, 5858449.248809035867453 ], [ 1385525.860647091642022, 5858475.8632338559255 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E39", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 754.29998779296875, "invlev_up": 751.79998779296875, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_503_generated", "manhole_dn": "manhole_504_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385525.860647091642022, 5858475.8632338559255 ], [ 1385553.357332118786871, 5858517.404887572862208 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E40", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 751.70001220703125, "invlev_up": 751.79998779296875, "invlev_dn": 749.20001220703125, "manhole_up": "manhole_504_generated", "manhole_dn": "manhole_505_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385553.357332118786871, 5858517.404887572862208 ], [ 1385579.617479301057756, 5858559.686364834196866 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E41", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.70001220703125, "elevtn_dn": 751.70001220703125, "invlev_up": 749.20001220703125, "invlev_dn": 749.20001220703125, "manhole_up": "manhole_505_generated", "manhole_dn": "manhole_506_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385579.617479301057756, 5858559.686364834196866 ], [ 1385621.905693766893819, 5858585.068030893802643 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E42", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.70001220703125, "elevtn_dn": 750.9000244140625, "invlev_up": 749.20001220703125, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_506_generated", "manhole_dn": "manhole_507_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385621.905693766893819, 5858585.068030893802643 ], [ 1385664.027273919200525, 5858611.351026647724211 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E43", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 750.9000244140625, "invlev_up": 748.4000244140625, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_507_generated", "manhole_dn": "manhole_508_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385664.027273919200525, 5858611.351026647724211 ], [ 1385700.387205619364977, 5858645.507954810746014 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E44", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 750.9000244140625, "invlev_up": 748.4000244140625, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_508_generated", "manhole_dn": "manhole_509_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385700.387205619364977, 5858645.507954810746014 ], [ 1385734.601841112133116, 5858681.909404612146318 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E45", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 755.79998779296875, "invlev_up": 748.4000244140625, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_509_generated", "manhole_dn": "manhole_510_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385734.601841112133116, 5858681.909404612146318 ], [ 1385768.816476604901254, 5858718.310854412615299 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E46", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_510_generated", "manhole_dn": "manhole_511_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385768.816476604901254, 5858718.310854412615299 ], [ 1385802.200311921536922, 5858755.447309947572649 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E47", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_511_generated", "manhole_dn": "manhole_512_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385802.200311921536922, 5858755.447309947572649 ], [ 1385834.15946239954792, 5858793.844178703613579 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_21_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_21", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 765.0, "invlev_up": 753.79998779296875, "invlev_dn": 762.5, "manhole_up": "manhole_513_generated", "manhole_dn": "manhole_514_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385352.471788094611838, 5858398.70255031902343 ], [ 1385323.609449510695413, 5858430.098599229939282 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_21_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_21", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 765.0, "elevtn_dn": 765.0, "invlev_up": 762.5, "invlev_dn": 762.5, "manhole_up": "manhole_514_generated", "manhole_dn": "manhole_515_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385323.609449510695413, 5858430.098599229939282 ], [ 1385286.388775944709778, 5858419.306091710925102 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_21_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_21", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 765.0, "elevtn_dn": 758.9000244140625, "invlev_up": 762.5, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_515_generated", "manhole_dn": "manhole_516_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385286.388775944709778, 5858419.306091710925102 ], [ 1385252.458742934046313, 5858394.201654580421746 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_21_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_21", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 758.9000244140625, "invlev_up": 756.4000244140625, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_516_generated", "manhole_dn": "manhole_517_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385252.458742934046313, 5858394.201654580421746 ], [ 1385217.536378393415362, 5858369.72360460460186 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_21_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_21", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 756.79998779296875, "invlev_up": 756.4000244140625, "invlev_dn": 754.29998779296875, "manhole_up": "manhole_517_generated", "manhole_dn": "manhole_518_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385217.536378393415362, 5858369.72360460460186 ], [ 1385177.877519500209019, 5858363.975667187944055 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_23_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_23", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "manhole_up": "manhole_519_generated", "manhole_dn": "manhole_520_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384748.107251951703802, 5858475.46539437584579 ], [ 1384773.662756133358926, 5858482.028828926384449 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_23_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_23", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "manhole_up": "manhole_520_generated", "manhole_dn": "manhole_521_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384773.662756133358926, 5858482.028828926384449 ], [ 1384799.21826031524688, 5858488.592263477854431 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_24_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_24", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_24", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.9000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 760.4000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_522_generated", "manhole_dn": "manhole_523_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385831.554474999429658, 5858837.476550582796335 ], [ 1385834.933234154479578, 5858795.367517679929733 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_24_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_24", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_24", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 748.9000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_523_generated", "manhole_dn": "manhole_524_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385834.933234154479578, 5858795.367517679929733 ], [ 1385855.640895856311545, 5858836.135079927742481 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_25_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_25", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.79998779296875, "elevtn_dn": 791.20001220703125, "invlev_up": 784.29998779296875, "invlev_dn": 788.70001220703125, "manhole_up": "manhole_525_generated", "manhole_dn": "manhole_526_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385425.871741503709927, 5858809.522038951516151 ], [ 1385446.216239683330059, 5858844.397748519666493 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_25_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_25", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 791.20001220703125, "elevtn_dn": 791.20001220703125, "invlev_up": 788.70001220703125, "invlev_dn": 788.70001220703125, "manhole_up": "manhole_526_generated", "manhole_dn": "manhole_527_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385446.216239683330059, 5858844.397748519666493 ], [ 1385453.998638280900195, 5858886.437654017470777 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_25_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_25", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 791.20001220703125, "elevtn_dn": 783.0, "invlev_up": 788.70001220703125, "invlev_dn": 780.5, "manhole_up": "manhole_527_generated", "manhole_dn": "manhole_528_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385453.998638280900195, 5858886.437654017470777 ], [ 1385472.218053022632375, 5858925.273072509095073 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_26_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_26", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_26", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.9000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 760.4000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_522_generated", "manhole_dn": "manhole_524_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385831.554474999429658, 5858837.476550582796335 ], [ 1385855.640895856311545, 5858836.135079927742481 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_29_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_29", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_29", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_529_generated", "manhole_dn": "manhole_530_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385861.372513797832653, 5858893.832569030113518 ], [ 1385844.630084188189358, 5858865.848266057670116 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_29_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_29", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_29", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 762.9000244140625, "invlev_up": 757.20001220703125, "invlev_dn": 760.4000244140625, "manhole_up": "manhole_530_generated", "manhole_dn": "manhole_522_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385844.630084188189358, 5858865.848266057670116 ], [ 1385831.554474999429658, 5858837.476550582796335 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_30_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 769.4000244140625, "invlev_up": 766.9000244140625, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_531_generated", "manhole_dn": "manhole_532_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387137.22300889948383, 5858981.723106959834695 ], [ 1387148.04859330272302, 5859026.366797789931297 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_30_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 762.60003662109375, "invlev_up": 766.9000244140625, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_532_generated", "manhole_dn": "manhole_533_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387148.04859330272302, 5859026.366797789931297 ], [ 1387119.95937648974359, 5859056.934598693624139 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_30_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 762.60003662109375, "invlev_up": 760.10003662109375, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_533_generated", "manhole_dn": "manhole_534_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387119.95937648974359, 5859056.934598693624139 ], [ 1387074.832296247361228, 5859065.30100557859987 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_30_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 755.79998779296875, "invlev_up": 760.10003662109375, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_534_generated", "manhole_dn": "manhole_535_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387074.832296247361228, 5859065.30100557859987 ], [ 1387030.356415221933275, 5859076.86137125454843 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_30_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 772.4000244140625, "invlev_up": 753.29998779296875, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_535_generated", "manhole_dn": "manhole_536_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387030.356415221933275, 5859076.86137125454843 ], [ 1386986.427998587489128, 5859090.309648380614817 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_30_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 761.60003662109375, "invlev_up": 769.9000244140625, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_536_generated", "manhole_dn": "manhole_537_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386986.427998587489128, 5859090.309648380614817 ], [ 1386945.966695382725447, 5859111.788386604748666 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_30_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_537_generated", "manhole_dn": "manhole_538_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386945.966695382725447, 5859111.788386604748666 ], [ 1386905.77102447184734, 5859134.105928846634924 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_30_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_538_generated", "manhole_dn": "manhole_539_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386905.77102447184734, 5859134.105928846634924 ], [ 1386871.537448140559718, 5859162.609670763835311 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_539_generated", "manhole_dn": "manhole_540_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386871.537448140559718, 5859162.609670763835311 ], [ 1386921.106019288301468, 5859163.103915391489863 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 772.4000244140625, "invlev_up": 759.10003662109375, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_540_generated", "manhole_dn": "manhole_541_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386921.106019288301468, 5859163.103915391489863 ], [ 1386970.627896018791944, 5859161.624508504755795 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 772.4000244140625, "invlev_up": 769.9000244140625, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_541_generated", "manhole_dn": "manhole_542_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386970.627896018791944, 5859161.624508504755795 ], [ 1387019.993600395740941, 5859157.412991388700902 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 781.10003662109375, "invlev_up": 769.9000244140625, "invlev_dn": 778.60003662109375, "manhole_up": "manhole_542_generated", "manhole_dn": "manhole_543_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387019.993600395740941, 5859157.412991388700902 ], [ 1387069.191225855611265, 5859151.340004274621606 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 781.10003662109375, "elevtn_dn": 781.10003662109375, "invlev_up": 778.60003662109375, "invlev_dn": 778.60003662109375, "manhole_up": "manhole_543_generated", "manhole_dn": "manhole_544_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387069.191225855611265, 5859151.340004274621606 ], [ 1387118.547863835236058, 5859146.828392788767815 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 781.10003662109375, "elevtn_dn": 786.4000244140625, "invlev_up": 778.60003662109375, "invlev_dn": 783.9000244140625, "manhole_up": "manhole_544_generated", "manhole_dn": "manhole_545_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387118.547863835236058, 5859146.828392788767815 ], [ 1387167.916038708761334, 5859151.025294326245785 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.4000244140625, "elevtn_dn": 786.4000244140625, "invlev_up": 783.9000244140625, "invlev_dn": 783.9000244140625, "manhole_up": "manhole_545_generated", "manhole_dn": "manhole_546_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387167.916038708761334, 5859151.025294326245785 ], [ 1387217.282604865729809, 5859155.523034786805511 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.4000244140625, "elevtn_dn": 787.60003662109375, "invlev_up": 783.9000244140625, "invlev_dn": 785.10003662109375, "manhole_up": "manhole_546_generated", "manhole_dn": "manhole_547_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387217.282604865729809, 5859155.523034786805511 ], [ 1387266.649171022465453, 5859160.020775248296559 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E8", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 787.60003662109375, "elevtn_dn": 787.60003662109375, "invlev_up": 785.10003662109375, "invlev_dn": 785.10003662109375, "manhole_up": "manhole_547_generated", "manhole_dn": "manhole_548_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387266.649171022465453, 5859160.020775248296559 ], [ 1387315.831188223091885, 5859165.716172898188233 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E9", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 787.60003662109375, "elevtn_dn": 790.4000244140625, "invlev_up": 785.10003662109375, "invlev_dn": 787.9000244140625, "manhole_up": "manhole_548_generated", "manhole_dn": "manhole_549_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387315.831188223091885, 5859165.716172898188233 ], [ 1387364.261764668161049, 5859176.288154195994139 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E10", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 790.4000244140625, "elevtn_dn": 790.4000244140625, "invlev_up": 787.9000244140625, "invlev_dn": 787.9000244140625, "manhole_up": "manhole_549_generated", "manhole_dn": "manhole_550_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387364.261764668161049, 5859176.288154195994139 ], [ 1387411.186259990092367, 5859192.118345031514764 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E11", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 790.4000244140625, "elevtn_dn": 789.10003662109375, "invlev_up": 787.9000244140625, "invlev_dn": 786.60003662109375, "manhole_up": "manhole_550_generated", "manhole_dn": "manhole_551_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387411.186259990092367, 5859192.118345031514764 ], [ 1387455.544592748628929, 5859213.906051598489285 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E12", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 789.10003662109375, "elevtn_dn": 817.20001220703125, "invlev_up": 786.60003662109375, "invlev_dn": 814.70001220703125, "manhole_up": "manhole_551_generated", "manhole_dn": "manhole_552_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387455.544592748628929, 5859213.906051598489285 ], [ 1387490.610425172373652, 5859248.94134864397347 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E13", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 817.20001220703125, "elevtn_dn": 818.20001220703125, "invlev_up": 814.70001220703125, "invlev_dn": 815.70001220703125, "manhole_up": "manhole_552_generated", "manhole_dn": "manhole_553_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387490.610425172373652, 5859248.94134864397347 ], [ 1387525.979065561201423, 5859283.669168318621814 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E14", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 818.20001220703125, "elevtn_dn": 818.20001220703125, "invlev_up": 815.70001220703125, "invlev_dn": 815.70001220703125, "manhole_up": "manhole_553_generated", "manhole_dn": "manhole_554_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387525.979065561201423, 5859283.669168318621814 ], [ 1387563.532416822388768, 5859316.0270627560094 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E15", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 818.20001220703125, "elevtn_dn": 802.79998779296875, "invlev_up": 815.70001220703125, "invlev_dn": 800.29998779296875, "manhole_up": "manhole_554_generated", "manhole_dn": "manhole_555_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387563.532416822388768, 5859316.0270627560094 ], [ 1387601.085768083808944, 5859348.384957193396986 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E16", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 802.79998779296875, "elevtn_dn": 837.70001220703125, "invlev_up": 800.29998779296875, "invlev_dn": 835.20001220703125, "manhole_up": "manhole_555_generated", "manhole_dn": "manhole_556_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387601.085768083808944, 5859348.384957193396986 ], [ 1387638.639119345229119, 5859380.742851630784571 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E17", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 837.70001220703125, "elevtn_dn": 837.70001220703125, "invlev_up": 835.20001220703125, "invlev_dn": 835.20001220703125, "manhole_up": "manhole_556_generated", "manhole_dn": "manhole_557_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387638.639119345229119, 5859380.742851630784571 ], [ 1387676.192470606416464, 5859413.100746068172157 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E18", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 837.70001220703125, "elevtn_dn": 828.79998779296875, "invlev_up": 835.20001220703125, "invlev_dn": 826.29998779296875, "manhole_up": "manhole_557_generated", "manhole_dn": "manhole_558_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387676.192470606416464, 5859413.100746068172157 ], [ 1387713.745821867836639, 5859445.45864050462842 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E19", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 828.79998779296875, "elevtn_dn": 828.79998779296875, "invlev_up": 826.29998779296875, "invlev_dn": 826.29998779296875, "manhole_up": "manhole_558_generated", "manhole_dn": "manhole_559_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387713.745821867836639, 5859445.45864050462842 ], [ 1387750.394377880264074, 5859478.825171477161348 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E20", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 828.79998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 826.29998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_559_generated", "manhole_dn": "manhole_560_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387750.394377880264074, 5859478.825171477161348 ], [ 1387786.626276910537854, 5859512.656178202480078 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E21", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 851.79998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_560_generated", "manhole_dn": "manhole_561_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387786.626276910537854, 5859512.656178202480078 ], [ 1387822.858175940578803, 5859546.487184926867485 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E22", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 851.79998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_561_generated", "manhole_dn": "manhole_562_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387822.858175940578803, 5859546.487184926867485 ], [ 1387850.662340233800933, 5859586.980695966631174 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E23", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 891.20001220703125, "invlev_up": 851.79998779296875, "invlev_dn": 888.70001220703125, "manhole_up": "manhole_562_generated", "manhole_dn": "manhole_563_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387850.662340233800933, 5859586.980695966631174 ], [ 1387868.193221996771172, 5859633.330900657922029 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E24", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 891.20001220703125, "elevtn_dn": 876.20001220703125, "invlev_up": 888.70001220703125, "invlev_dn": 873.70001220703125, "manhole_up": "manhole_563_generated", "manhole_dn": "manhole_564_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387868.193221996771172, 5859633.330900657922029 ], [ 1387885.535610173596069, 5859679.769344814121723 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E25", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 876.20001220703125, "elevtn_dn": 876.20001220703125, "invlev_up": 873.70001220703125, "invlev_dn": 873.70001220703125, "manhole_up": "manhole_564_generated", "manhole_dn": "manhole_565_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387885.535610173596069, 5859679.769344814121723 ], [ 1387902.854485532967374, 5859726.216552678495646 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E26", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 876.20001220703125, "elevtn_dn": 898.29998779296875, "invlev_up": 873.70001220703125, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_565_generated", "manhole_dn": "manhole_566_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387902.854485532967374, 5859726.216552678495646 ], [ 1387920.137465380365029, 5859772.67713953461498 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E27", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 898.29998779296875, "invlev_up": 895.79998779296875, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_566_generated", "manhole_dn": "manhole_567_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387920.137465380365029, 5859772.67713953461498 ], [ 1387937.420445227529854, 5859819.137726389802992 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E28", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 898.29998779296875, "invlev_up": 895.79998779296875, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_567_generated", "manhole_dn": "manhole_568_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387937.420445227529854, 5859819.137726389802992 ], [ 1387948.863530882401392, 5859867.082766367122531 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E29", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 918.5, "invlev_up": 895.79998779296875, "invlev_dn": 916.0, "manhole_up": "manhole_568_generated", "manhole_dn": "manhole_569_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387948.863530882401392, 5859867.082766367122531 ], [ 1387950.013254075078294, 5859916.565449987538159 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E30", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 918.5, "invlev_up": 916.0, "invlev_dn": 916.0, "manhole_up": "manhole_569_generated", "manhole_dn": "manhole_570_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387950.013254075078294, 5859916.565449987538159 ], [ 1387947.430782878771424, 5859966.047936389222741 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E31", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 918.5, "invlev_up": 916.0, "invlev_dn": 916.0, "manhole_up": "manhole_570_generated", "manhole_dn": "manhole_571_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387947.430782878771424, 5859966.047936389222741 ], [ 1387943.997958281077445, 5860015.499966060742736 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E32", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 948.60003662109375, "invlev_up": 916.0, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_571_generated", "manhole_dn": "manhole_572_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387943.997958281077445, 5860015.499966060742736 ], [ 1387940.565133683150634, 5860064.951995733194053 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E33", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 948.60003662109375, "invlev_up": 946.10003662109375, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_572_generated", "manhole_dn": "manhole_573_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.565133683150634, 5860064.951995733194053 ], [ 1387945.371777657186612, 5860113.959104515612125 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E34", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 948.60003662109375, "invlev_up": 946.10003662109375, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_573_generated", "manhole_dn": "manhole_574_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387945.371777657186612, 5860113.959104515612125 ], [ 1387964.117816498270258, 5860159.736532494425774 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E35", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 940.5, "invlev_up": 946.10003662109375, "invlev_dn": 938.0, "manhole_up": "manhole_574_generated", "manhole_dn": "manhole_575_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387964.117816498270258, 5860159.736532494425774 ], [ 1387984.093857799191028, 5860205.104420888237655 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E36", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 940.5, "invlev_up": 938.0, "invlev_dn": 938.0, "manhole_up": "manhole_575_generated", "manhole_dn": "manhole_576_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387984.093857799191028, 5860205.104420888237655 ], [ 1388004.069899099878967, 5860250.472309282049537 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E37", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 940.5, "invlev_up": 938.0, "invlev_dn": 938.0, "manhole_up": "manhole_576_generated", "manhole_dn": "manhole_577_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388004.069899099878967, 5860250.472309282049537 ], [ 1388027.68692572391592, 5860293.896034284494817 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E38", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 971.70001220703125, "invlev_up": 938.0, "invlev_dn": 969.20001220703125, "manhole_up": "manhole_577_generated", "manhole_dn": "manhole_578_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388027.68692572391592, 5860293.896034284494817 ], [ 1388060.096315970877185, 5860331.348726416006684 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E39", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 971.70001220703125, "elevtn_dn": 935.5, "invlev_up": 969.20001220703125, "invlev_dn": 933.0, "manhole_up": "manhole_578_generated", "manhole_dn": "manhole_579_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388060.096315970877185, 5860331.348726416006684 ], [ 1388092.967688721138984, 5860368.453448176383972 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E40", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 935.5, "invlev_up": 933.0, "invlev_dn": 933.0, "manhole_up": "manhole_579_generated", "manhole_dn": "manhole_580_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388092.967688721138984, 5860368.453448176383972 ], [ 1388119.020827289205045, 5860410.510251956991851 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E41", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 949.9000244140625, "invlev_up": 933.0, "invlev_dn": 947.4000244140625, "manhole_up": "manhole_580_generated", "manhole_dn": "manhole_581_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388119.020827289205045, 5860410.510251956991851 ], [ 1388143.407622833969072, 5860453.667774203233421 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E42", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 949.9000244140625, "elevtn_dn": 924.60003662109375, "invlev_up": 947.4000244140625, "invlev_dn": 922.10003662109375, "manhole_up": "manhole_581_generated", "manhole_dn": "manhole_582_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388143.407622833969072, 5860453.667774203233421 ], [ 1388167.794418378733099, 5860496.82529644947499 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E43", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 924.60003662109375, "elevtn_dn": 924.60003662109375, "invlev_up": 922.10003662109375, "invlev_dn": 922.10003662109375, "manhole_up": "manhole_582_generated", "manhole_dn": "manhole_583_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388167.794418378733099, 5860496.82529644947499 ], [ 1388187.41186453984119, 5860542.097804954275489 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E44", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 924.60003662109375, "elevtn_dn": 942.4000244140625, "invlev_up": 922.10003662109375, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_583_generated", "manhole_dn": "manhole_584_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388187.41186453984119, 5860542.097804954275489 ], [ 1388193.385166377527639, 5860591.251542154699564 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E45", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 942.4000244140625, "invlev_up": 939.9000244140625, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_584_generated", "manhole_dn": "manhole_585_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388193.385166377527639, 5860591.251542154699564 ], [ 1388198.812296225922182, 5860640.524595490656793 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E46", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 942.4000244140625, "invlev_up": 939.9000244140625, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_585_generated", "manhole_dn": "manhole_586_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388198.812296225922182, 5860640.524595490656793 ], [ 1388204.239426074549556, 5860689.7976488256827 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E47", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 955.0, "invlev_up": 939.9000244140625, "invlev_dn": 952.5, "manhole_up": "manhole_586_generated", "manhole_dn": "manhole_587_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388204.239426074549556, 5860689.7976488256827 ], [ 1388184.484932377934456, 5860730.700381714850664 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E48", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_587_generated", "manhole_dn": "manhole_588_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388184.484932377934456, 5860730.700381714850664 ], [ 1388159.550175313837826, 5860759.392759991809726 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E49", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_588_generated", "manhole_dn": "manhole_589_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388159.550175313837826, 5860759.392759991809726 ], [ 1388171.988544700434431, 5860807.377908634953201 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E50", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_589_generated", "manhole_dn": "manhole_590_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388171.988544700434431, 5860807.377908634953201 ], [ 1388215.013825689908117, 5860825.214942933060229 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E51", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 941.10003662109375, "invlev_up": 952.5, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_590_generated", "manhole_dn": "manhole_591_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388215.013825689908117, 5860825.214942933060229 ], [ 1388264.397385431453586, 5860829.298032846301794 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E52", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_591_generated", "manhole_dn": "manhole_592_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388264.397385431453586, 5860829.298032846301794 ], [ 1388313.062299854354933, 5860837.304878970608115 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E53", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 937.5, "invlev_up": 938.60003662109375, "invlev_dn": 935.0, "manhole_up": "manhole_592_generated", "manhole_dn": "manhole_593_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388313.062299854354933, 5860837.304878970608115 ], [ 1388360.993895401246846, 5860849.948045967146754 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E54", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.5, "elevtn_dn": 937.5, "invlev_up": 935.0, "invlev_dn": 935.0, "manhole_up": "manhole_593_generated", "manhole_dn": "manhole_594_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388360.993895401246846, 5860849.948045967146754 ], [ 1388408.925490947905928, 5860862.591212964616716 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E55", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.5, "elevtn_dn": 937.60003662109375, "invlev_up": 935.0, "invlev_dn": 935.10003662109375, "manhole_up": "manhole_594_generated", "manhole_dn": "manhole_595_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388408.925490947905928, 5860862.591212964616716 ], [ 1388458.220990223577246, 5860866.957201769575477 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E56", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.60003662109375, "elevtn_dn": 937.60003662109375, "invlev_up": 935.10003662109375, "invlev_dn": 935.10003662109375, "manhole_up": "manhole_595_generated", "manhole_dn": "manhole_596_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388458.220990223577246, 5860866.957201769575477 ], [ 1388507.336333080893382, 5860873.218384950421751 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E57", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.60003662109375, "elevtn_dn": 941.20001220703125, "invlev_up": 935.10003662109375, "invlev_dn": 938.70001220703125, "manhole_up": "manhole_596_generated", "manhole_dn": "manhole_597_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388507.336333080893382, 5860873.218384950421751 ], [ 1388556.215695114107803, 5860881.470384138636291 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E58", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.20001220703125, "elevtn_dn": 941.20001220703125, "invlev_up": 938.70001220703125, "invlev_dn": 938.70001220703125, "manhole_up": "manhole_597_generated", "manhole_dn": "manhole_598_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388556.215695114107803, 5860881.470384138636291 ], [ 1388604.556662159739062, 5860892.361969010904431 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E59", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.20001220703125, "elevtn_dn": 943.10003662109375, "invlev_up": 938.70001220703125, "invlev_dn": 940.60003662109375, "manhole_up": "manhole_598_generated", "manhole_dn": "manhole_599_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388604.556662159739062, 5860892.361969010904431 ], [ 1388653.59940263046883, 5860897.15789801068604 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E60", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 943.10003662109375, "elevtn_dn": 943.10003662109375, "invlev_up": 940.60003662109375, "invlev_dn": 940.60003662109375, "manhole_up": "manhole_599_generated", "manhole_dn": "manhole_600_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388653.59940263046883, 5860897.15789801068604 ], [ 1388700.080393208190799, 5860881.090511013753712 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E61", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 943.10003662109375, "elevtn_dn": 946.10003662109375, "invlev_up": 940.60003662109375, "invlev_dn": 943.60003662109375, "manhole_up": "manhole_600_generated", "manhole_dn": "manhole_601_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388700.080393208190799, 5860881.090511013753712 ], [ 1388732.687003659084439, 5860844.794781206175685 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E62", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 946.10003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 943.60003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_601_generated", "manhole_dn": "manhole_602_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388732.687003659084439, 5860844.794781206175685 ], [ 1388755.953327334951609, 5860801.023035684600472 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E63", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 950.10003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_602_generated", "manhole_dn": "manhole_603_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388755.953327334951609, 5860801.023035684600472 ], [ 1388778.23369869007729, 5860756.84024004638195 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E64", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 950.10003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_603_generated", "manhole_dn": "manhole_604_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388778.23369869007729, 5860756.84024004638195 ], [ 1388792.950793598080054, 5860709.504263866692781 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E65", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 953.79998779296875, "invlev_up": 950.10003662109375, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_604_generated", "manhole_dn": "manhole_605_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388792.950793598080054, 5860709.504263866692781 ], [ 1388807.667888506315649, 5860662.168287687934935 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E66", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_605_generated", "manhole_dn": "manhole_606_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388807.667888506315649, 5860662.168287687934935 ], [ 1388819.224422588944435, 5860613.968191100284457 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E67", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 955.70001220703125, "invlev_up": 951.29998779296875, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_606_generated", "manhole_dn": "manhole_607_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388819.224422588944435, 5860613.968191100284457 ], [ 1388830.63825476472266, 5860565.72907877061516 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E68", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_607_generated", "manhole_dn": "manhole_608_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388830.63825476472266, 5860565.72907877061516 ], [ 1388842.052086940500885, 5860517.489966440014541 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E69", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_608_generated", "manhole_dn": "manhole_609_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388842.052086940500885, 5860517.489966440014541 ], [ 1388862.77624000934884, 5860472.578981296159327 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E70", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 964.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_609_generated", "manhole_dn": "manhole_610_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388862.77624000934884, 5860472.578981296159327 ], [ 1388884.529400010826066, 5860428.03588358964771 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E71", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 951.29998779296875, "invlev_up": 962.20001220703125, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_610_generated", "manhole_dn": "manhole_611_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388884.529400010826066, 5860428.03588358964771 ], [ 1388906.282637836178765, 5860383.492823889479041 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E72", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_611_generated", "manhole_dn": "manhole_612_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388906.282637836178765, 5860383.492823889479041 ], [ 1388933.946375871310011, 5860342.419800435192883 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E73", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_612_generated", "manhole_dn": "manhole_613_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388933.946375871310011, 5860342.419800435192883 ], [ 1388962.240715913940221, 5860301.717001453973353 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_33_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 752.29998779296875, "invlev_up": 759.10003662109375, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_539_generated", "manhole_dn": "manhole_614_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386871.537448140559718, 5859162.609670763835311 ], [ 1386825.19834817154333, 5859175.156894122250378 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_33_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 752.29998779296875, "invlev_up": 749.79998779296875, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_614_generated", "manhole_dn": "manhole_615_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386825.19834817154333, 5859175.156894122250378 ], [ 1386779.333999397465959, 5859189.44842192158103 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_33_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 738.0, "invlev_up": 749.79998779296875, "invlev_dn": 735.5, "manhole_up": "manhole_615_generated", "manhole_dn": "manhole_616_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386779.333999397465959, 5859189.44842192158103 ], [ 1386733.445003136992455, 5859203.660136871039867 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_33_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 738.0, "invlev_up": 735.5, "invlev_dn": 735.5, "manhole_up": "manhole_616_generated", "manhole_dn": "manhole_617_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386733.445003136992455, 5859203.660136871039867 ], [ 1386687.508546756347641, 5859217.718167688697577 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_33_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 763.29998779296875, "invlev_up": 735.5, "invlev_dn": 760.79998779296875, "manhole_up": "manhole_617_generated", "manhole_dn": "manhole_618_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386687.508546756347641, 5859217.718167688697577 ], [ 1386641.572090375469998, 5859231.776198507286608 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_33_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 763.29998779296875, "elevtn_dn": 763.29998779296875, "invlev_up": 760.79998779296875, "invlev_dn": 760.79998779296875, "manhole_up": "manhole_618_generated", "manhole_dn": "manhole_619_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386641.572090375469998, 5859231.776198507286608 ], [ 1386595.451642262749374, 5859245.168246414512396 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_33_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 763.29998779296875, "elevtn_dn": 754.60003662109375, "invlev_up": 760.79998779296875, "invlev_dn": 752.10003662109375, "manhole_up": "manhole_619_generated", "manhole_dn": "manhole_620_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386595.451642262749374, 5859245.168246414512396 ], [ 1386548.813360751140863, 5859256.685926430858672 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_33_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 754.60003662109375, "elevtn_dn": 754.60003662109375, "invlev_up": 752.10003662109375, "invlev_dn": 752.10003662109375, "manhole_up": "manhole_620_generated", "manhole_dn": "manhole_621_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386548.813360751140863, 5859256.685926430858672 ], [ 1386502.175079239532351, 5859268.203606447204947 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_33_E8", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 754.60003662109375, "elevtn_dn": 742.5, "invlev_up": 752.10003662109375, "invlev_dn": 740.0, "manhole_up": "manhole_621_generated", "manhole_dn": "manhole_622_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386502.175079239532351, 5859268.203606447204947 ], [ 1386455.354356503346935, 5859278.943273726850748 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_33_E9", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 742.5, "invlev_up": 740.0, "invlev_dn": 740.0, "manhole_up": "manhole_622_generated", "manhole_dn": "manhole_623_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386455.354356503346935, 5859278.943273726850748 ], [ 1386408.879239794565365, 5859290.671229789964855 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_33_E10", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 717.60003662109375, "invlev_up": 740.0, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_623_generated", "manhole_dn": "manhole_624_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386408.879239794565365, 5859290.671229789964855 ], [ 1386364.691368696978316, 5859309.518465746194124 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_33_E11", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 717.60003662109375, "invlev_up": 715.10003662109375, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_624_generated", "manhole_dn": "manhole_625_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386364.691368696978316, 5859309.518465746194124 ], [ 1386320.503497599391267, 5859328.365701701492071 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_33_E12", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 711.0, "invlev_up": 715.10003662109375, "invlev_dn": 708.5, "manhole_up": "manhole_625_generated", "manhole_dn": "manhole_626_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386320.503497599391267, 5859328.365701701492071 ], [ 1386273.173811787506565, 5859335.36546028777957 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 953.70001220703125, "invlev_up": 948.79998779296875, "invlev_dn": 951.20001220703125, "manhole_up": "manhole_10_generated", "manhole_dn": "manhole_627_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388946.301100668497384, 5860414.883977899327874 ], [ 1388922.246059404918924, 5860458.418739438988268 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.70001220703125, "elevtn_dn": 953.70001220703125, "invlev_up": 951.20001220703125, "invlev_dn": 951.20001220703125, "manhole_up": "manhole_627_generated", "manhole_dn": "manhole_628_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388922.246059404918924, 5860458.418739438988268 ], [ 1388900.295977992936969, 5860503.075897979550064 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 951.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_628_generated", "manhole_dn": "manhole_629_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388900.295977992936969, 5860503.075897979550064 ], [ 1388878.345896581187844, 5860547.733056520111859 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 953.79998779296875, "invlev_up": 953.20001220703125, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_629_generated", "manhole_dn": "manhole_630_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388878.345896581187844, 5860547.733056520111859 ], [ 1388856.887740465346724, 5860592.570927501656115 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_630_generated", "manhole_dn": "manhole_631_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388856.887740465346724, 5860592.570927501656115 ], [ 1388853.076019846601412, 5860641.795407227240503 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_631_generated", "manhole_dn": "manhole_632_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388853.076019846601412, 5860641.795407227240503 ], [ 1388856.119826921960339, 5860691.462329030036926 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 952.5, "invlev_up": 951.29998779296875, "invlev_dn": 950.0, "manhole_up": "manhole_632_generated", "manhole_dn": "manhole_633_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388856.119826921960339, 5860691.462329030036926 ], [ 1388859.163633997086436, 5860741.12925083283335 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.5, "elevtn_dn": 952.5, "invlev_up": 950.0, "invlev_dn": 950.0, "manhole_up": "manhole_633_generated", "manhole_dn": "manhole_634_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388859.163633997086436, 5860741.12925083283335 ], [ 1388862.207441072445363, 5860790.796172635629773 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E8", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.5, "elevtn_dn": 945.5, "invlev_up": 950.0, "invlev_dn": 943.0, "manhole_up": "manhole_634_generated", "manhole_dn": "manhole_635_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388862.207441072445363, 5860790.796172635629773 ], [ 1388866.356326055014506, 5860840.344227194786072 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E9", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 945.5, "invlev_up": 943.0, "invlev_dn": 943.0, "manhole_up": "manhole_635_generated", "manhole_dn": "manhole_636_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388866.356326055014506, 5860840.344227194786072 ], [ 1388873.944740658160299, 5860889.522310186177492 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E10", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 945.5, "invlev_up": 943.0, "invlev_dn": 943.0, "manhole_up": "manhole_636_generated", "manhole_dn": "manhole_637_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388873.944740658160299, 5860889.522310186177492 ], [ 1388883.17427325528115, 5860938.398467163555324 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E11", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 937.4000244140625, "invlev_up": 943.0, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_637_generated", "manhole_dn": "manhole_638_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388883.17427325528115, 5860938.398467163555324 ], [ 1388890.216840920504183, 5860987.212368851527572 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E12", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 937.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_638_generated", "manhole_dn": "manhole_639_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388890.216840920504183, 5860987.212368851527572 ], [ 1388884.322194910608232, 5861036.62209493201226 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E13", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 937.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_639_generated", "manhole_dn": "manhole_640_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388884.322194910608232, 5861036.62209493201226 ], [ 1388878.427548900712281, 5861086.031821011565626 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E14", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_640_generated", "manhole_dn": "manhole_641_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388878.427548900712281, 5861086.031821011565626 ], [ 1388872.532902890816331, 5861135.441547092050314 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E15", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 927.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_641_generated", "manhole_dn": "manhole_642_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388872.532902890816331, 5861135.441547092050314 ], [ 1388866.63825688092038, 5861184.851273172535002 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E16", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 927.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_642_generated", "manhole_dn": "manhole_643_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388866.63825688092038, 5861184.851273172535002 ], [ 1388854.620840607210994, 5861232.489912945777178 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E17", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 926.60003662109375, "invlev_up": 927.9000244140625, "invlev_dn": 924.10003662109375, "manhole_up": "manhole_643_generated", "manhole_dn": "manhole_644_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388854.620840607210994, 5861232.489912945777178 ], [ 1388833.22756120422855, 5861277.416469449177384 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E18", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 926.60003662109375, "elevtn_dn": 926.60003662109375, "invlev_up": 924.10003662109375, "invlev_dn": 924.10003662109375, "manhole_up": "manhole_644_generated", "manhole_dn": "manhole_645_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388833.22756120422855, 5861277.416469449177384 ], [ 1388811.834281801246107, 5861322.343025953508914 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E19", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 926.60003662109375, "elevtn_dn": 931.10003662109375, "invlev_up": 924.10003662109375, "invlev_dn": 928.60003662109375, "manhole_up": "manhole_645_generated", "manhole_dn": "manhole_646_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388811.834281801246107, 5861322.343025953508914 ], [ 1388790.441002398030832, 5861367.26958245690912 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E20", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 931.10003662109375, "elevtn_dn": 922.20001220703125, "invlev_up": 928.60003662109375, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_646_generated", "manhole_dn": "manhole_647_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388790.441002398030832, 5861367.26958245690912 ], [ 1388769.047722995048389, 5861412.196138960309327 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E21", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 922.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_647_generated", "manhole_dn": "manhole_648_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388769.047722995048389, 5861412.196138960309327 ], [ 1388747.654443592065945, 5861457.122695464640856 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E22", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 922.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_648_generated", "manhole_dn": "manhole_649_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388747.654443592065945, 5861457.122695464640856 ], [ 1388725.026126575190574, 5861501.410491958260536 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E23", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_649_generated", "manhole_dn": "manhole_650_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388725.026126575190574, 5861501.410491958260536 ], [ 1388700.725248141447082, 5861544.833241644315422 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E24", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_650_generated", "manhole_dn": "manhole_651_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388700.725248141447082, 5861544.833241644315422 ], [ 1388676.42436970770359, 5861588.255991329438984 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E25", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_651_generated", "manhole_dn": "manhole_652_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388676.42436970770359, 5861588.255991329438984 ], [ 1388632.324464634526521, 5861606.441272142343223 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E26", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 898.4000244140625, "invlev_up": 897.70001220703125, "invlev_dn": 895.9000244140625, "manhole_up": "manhole_652_generated", "manhole_dn": "manhole_653_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388632.324464634526521, 5861606.441272142343223 ], [ 1388583.463808472501114, 5861611.105615227483213 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E27", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 898.4000244140625, "elevtn_dn": 898.4000244140625, "invlev_up": 895.9000244140625, "invlev_dn": 895.9000244140625, "manhole_up": "manhole_653_generated", "manhole_dn": "manhole_654_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388583.463808472501114, 5861611.105615227483213 ], [ 1388534.764012826373801, 5861604.222017968073487 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E28", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 898.4000244140625, "elevtn_dn": 903.60003662109375, "invlev_up": 895.9000244140625, "invlev_dn": 901.10003662109375, "manhole_up": "manhole_654_generated", "manhole_dn": "manhole_655_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388534.764012826373801, 5861604.222017968073487 ], [ 1388489.566489090910181, 5861583.40731808822602 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E29", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 903.60003662109375, "elevtn_dn": 903.60003662109375, "invlev_up": 901.10003662109375, "invlev_dn": 901.10003662109375, "manhole_up": "manhole_655_generated", "manhole_dn": "manhole_656_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388489.566489090910181, 5861583.40731808822602 ], [ 1388444.204915680922568, 5861563.162508152425289 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E30", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 903.60003662109375, "elevtn_dn": 906.4000244140625, "invlev_up": 901.10003662109375, "invlev_dn": 903.9000244140625, "manhole_up": "manhole_656_generated", "manhole_dn": "manhole_657_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388444.204915680922568, 5861563.162508152425289 ], [ 1388394.858231473481283, 5861556.761520680040121 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E31", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 906.4000244140625, "elevtn_dn": 906.4000244140625, "invlev_up": 903.9000244140625, "invlev_dn": 903.9000244140625, "manhole_up": "manhole_657_generated", "manhole_dn": "manhole_658_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388394.858231473481283, 5861556.761520680040121 ], [ 1388350.680838279658929, 5861570.408674017526209 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E32", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 906.4000244140625, "elevtn_dn": 900.20001220703125, "invlev_up": 903.9000244140625, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_658_generated", "manhole_dn": "manhole_659_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388350.680838279658929, 5861570.408674017526209 ], [ 1388310.581732882419601, 5861599.872713611461222 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E33", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_659_generated", "manhole_dn": "manhole_660_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388310.581732882419601, 5861599.872713611461222 ], [ 1388271.039625711739063, 5861629.969603477045894 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E34", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 890.0, "invlev_up": 897.70001220703125, "invlev_dn": 887.5, "manhole_up": "manhole_660_generated", "manhole_dn": "manhole_661_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388271.039625711739063, 5861629.969603477045894 ], [ 1388236.722210306907073, 5861666.002683873288333 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E35", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 890.0, "invlev_up": 887.5, "invlev_dn": 887.5, "manhole_up": "manhole_661_generated", "manhole_dn": "manhole_662_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388236.722210306907073, 5861666.002683873288333 ], [ 1388202.404794902307913, 5861702.035764269530773 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E36", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 890.0, "invlev_up": 887.5, "invlev_dn": 887.5, "manhole_up": "manhole_662_generated", "manhole_dn": "manhole_663_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388202.404794902307913, 5861702.035764269530773 ], [ 1388168.087379497475922, 5861738.068844665773213 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E37", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 885.9000244140625, "invlev_up": 887.5, "invlev_dn": 883.4000244140625, "manhole_up": "manhole_663_generated", "manhole_dn": "manhole_664_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388168.087379497475922, 5861738.068844665773213 ], [ 1388133.769964092643932, 5861774.101925062015653 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E38", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 885.9000244140625, "elevtn_dn": 874.0, "invlev_up": 883.4000244140625, "invlev_dn": 871.5, "manhole_up": "manhole_664_generated", "manhole_dn": "manhole_665_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388133.769964092643932, 5861774.101925062015653 ], [ 1388099.452548687811941, 5861810.13500545732677 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E39", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 874.0, "elevtn_dn": 874.0, "invlev_up": 871.5, "invlev_dn": 871.5, "manhole_up": "manhole_665_generated", "manhole_dn": "manhole_666_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388099.452548687811941, 5861810.13500545732677 ], [ 1388065.135133283212781, 5861846.16808585356921 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E40", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 874.0, "elevtn_dn": 862.20001220703125, "invlev_up": 871.5, "invlev_dn": 859.70001220703125, "manhole_up": "manhole_666_generated", "manhole_dn": "manhole_667_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388065.135133283212781, 5861846.16808585356921 ], [ 1388022.995196633273736, 5861866.899685021489859 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E41", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 862.20001220703125, "elevtn_dn": 862.20001220703125, "invlev_up": 859.70001220703125, "invlev_dn": 859.70001220703125, "manhole_up": "manhole_667_generated", "manhole_dn": "manhole_668_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388022.995196633273736, 5861866.899685021489859 ], [ 1387973.690499771386385, 5861873.616436487063766 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E42", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 862.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 859.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_668_generated", "manhole_dn": "manhole_669_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387973.690499771386385, 5861873.616436487063766 ], [ 1387924.470484273741022, 5861880.90659652557224 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E43", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_669_generated", "manhole_dn": "manhole_670_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387924.470484273741022, 5861880.90659652557224 ], [ 1387877.962616891367361, 5861896.157046243548393 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E44", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_670_generated", "manhole_dn": "manhole_671_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387877.962616891367361, 5861896.157046243548393 ], [ 1387917.070526217576116, 5861911.915829903446138 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E45", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_671_generated", "manhole_dn": "manhole_672_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387917.070526217576116, 5861911.915829903446138 ], [ 1387966.654667611001059, 5861916.096835186704993 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E46", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 846.29998779296875, "invlev_up": 856.70001220703125, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_672_generated", "manhole_dn": "manhole_673_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387966.654667611001059, 5861916.096835186704993 ], [ 1388016.318005530629307, 5861919.063731476664543 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E47", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 850.10003662109375, "invlev_up": 843.79998779296875, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_673_generated", "manhole_dn": "manhole_674_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388016.318005530629307, 5861919.063731476664543 ], [ 1388066.025120510486886, 5861921.359510923735797 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E48", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 850.10003662109375, "invlev_up": 847.60003662109375, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_674_generated", "manhole_dn": "manhole_675_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388066.025120510486886, 5861921.359510923735797 ], [ 1388115.732235490344465, 5861923.655290370807052 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E49", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 849.0, "invlev_up": 847.60003662109375, "invlev_dn": 846.5, "manhole_up": "manhole_675_generated", "manhole_dn": "manhole_676_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388115.732235490344465, 5861923.655290370807052 ], [ 1388161.130695321131498, 5861931.457672152668238 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E50", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 849.0, "elevtn_dn": 850.10003662109375, "invlev_up": 846.5, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_676_generated", "manhole_dn": "manhole_677_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388161.130695321131498, 5861931.457672152668238 ], [ 1388139.871223766123876, 5861964.082641129381955 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E51", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 850.10003662109375, "invlev_up": 847.60003662109375, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_677_generated", "manhole_dn": "manhole_678_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388139.871223766123876, 5861964.082641129381955 ], [ 1388090.726845995755866, 5861957.769498392008245 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E52", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 846.29998779296875, "invlev_up": 847.60003662109375, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_678_generated", "manhole_dn": "manhole_679_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388090.726845995755866, 5861957.769498392008245 ], [ 1388049.339104855433106, 5861983.736727176234126 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E53", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 846.29998779296875, "invlev_up": 843.79998779296875, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_679_generated", "manhole_dn": "manhole_680_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388049.339104855433106, 5861983.736727176234126 ], [ 1388024.713075590552762, 5862026.975905770435929 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E54", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 846.29998779296875, "invlev_up": 843.79998779296875, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_680_generated", "manhole_dn": "manhole_681_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388024.713075590552762, 5862026.975905770435929 ], [ 1387980.016218039905652, 5862047.702198376879096 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E55", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 793.5, "invlev_up": 843.79998779296875, "invlev_dn": 791.0, "manhole_up": "manhole_681_generated", "manhole_dn": "manhole_682_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387980.016218039905652, 5862047.702198376879096 ], [ 1387931.90673128189519, 5862056.853296543471515 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E56", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.5, "elevtn_dn": 793.5, "invlev_up": 791.0, "invlev_dn": 791.0, "manhole_up": "manhole_682_generated", "manhole_dn": "manhole_683_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387931.90673128189519, 5862056.853296543471515 ], [ 1387882.187313467729837, 5862058.865105460397899 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E57", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.5, "elevtn_dn": 793.20001220703125, "invlev_up": 791.0, "invlev_dn": 790.70001220703125, "manhole_up": "manhole_683_generated", "manhole_dn": "manhole_684_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387882.187313467729837, 5862058.865105460397899 ], [ 1387832.722497318405658, 5862057.3410848621279 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E58", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.20001220703125, "elevtn_dn": 830.29998779296875, "invlev_up": 790.70001220703125, "invlev_dn": 827.79998779296875, "manhole_up": "manhole_684_generated", "manhole_dn": "manhole_685_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387832.722497318405658, 5862057.3410848621279 ], [ 1387783.80423084856011, 5862048.226750630885363 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E59", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 830.29998779296875, "elevtn_dn": 817.70001220703125, "invlev_up": 827.79998779296875, "invlev_dn": 815.20001220703125, "manhole_up": "manhole_685_generated", "manhole_dn": "manhole_686_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387783.80423084856011, 5862048.226750630885363 ], [ 1387734.885964378714561, 5862039.112416399642825 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E60", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 817.70001220703125, "elevtn_dn": 813.70001220703125, "invlev_up": 815.20001220703125, "invlev_dn": 811.20001220703125, "manhole_up": "manhole_686_generated", "manhole_dn": "manhole_687_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387734.885964378714561, 5862039.112416399642825 ], [ 1387685.967697908869013, 5862029.998082168400288 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E61", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 813.70001220703125, "elevtn_dn": 813.70001220703125, "invlev_up": 811.20001220703125, "invlev_dn": 811.20001220703125, "manhole_up": "manhole_687_generated", "manhole_dn": "manhole_688_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387685.967697908869013, 5862029.998082168400288 ], [ 1387637.036115845199674, 5862020.957140567712486 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E62", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 813.70001220703125, "elevtn_dn": 807.0, "invlev_up": 811.20001220703125, "invlev_dn": 804.5, "manhole_up": "manhole_688_generated", "manhole_dn": "manhole_689_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387637.036115845199674, 5862020.957140567712486 ], [ 1387588.033849656581879, 5862012.305794355459511 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E63", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.0, "elevtn_dn": 807.0, "invlev_up": 804.5, "invlev_dn": 804.5, "manhole_up": "manhole_689_generated", "manhole_dn": "manhole_690_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387588.033849656581879, 5862012.305794355459511 ], [ 1387539.031583468196914, 5862003.654448143206537 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E64", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.0, "elevtn_dn": 793.10003662109375, "invlev_up": 804.5, "invlev_dn": 790.60003662109375, "manhole_up": "manhole_690_generated", "manhole_dn": "manhole_691_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387539.031583468196914, 5862003.654448143206537 ], [ 1387490.029317279579118, 5861995.003101930953562 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E65", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.10003662109375, "elevtn_dn": 793.10003662109375, "invlev_up": 790.60003662109375, "invlev_dn": 790.60003662109375, "manhole_up": "manhole_691_generated", "manhole_dn": "manhole_692_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387490.029317279579118, 5861995.003101930953562 ], [ 1387440.720367865404114, 5861989.908138634636998 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E66", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.10003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 790.60003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_692_generated", "manhole_dn": "manhole_693_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387440.720367865404114, 5861989.908138634636998 ], [ 1387390.960446665296331, 5861990.042768024839461 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E67", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_693_generated", "manhole_dn": "manhole_694_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387390.960446665296331, 5861990.042768024839461 ], [ 1387341.200525465421379, 5861990.177397414110601 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E68", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 749.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 747.10003662109375, "manhole_up": "manhole_694_generated", "manhole_dn": "manhole_695_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387341.200525465421379, 5861990.177397414110601 ], [ 1387291.440604265546426, 5861990.312026804313064 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E69", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 749.60003662109375, "elevtn_dn": 749.60003662109375, "invlev_up": 747.10003662109375, "invlev_dn": 747.10003662109375, "manhole_up": "manhole_695_generated", "manhole_dn": "manhole_696_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387291.440604265546426, 5861990.312026804313064 ], [ 1387246.706285298336297, 5861974.212805554270744 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E70", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 749.60003662109375, "elevtn_dn": 747.0, "invlev_up": 747.10003662109375, "invlev_dn": 744.5, "manhole_up": "manhole_696_generated", "manhole_dn": "manhole_697_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387246.706285298336297, 5861974.212805554270744 ], [ 1387205.725988702848554, 5861945.987228964455426 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E71", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.0, "elevtn_dn": 771.79998779296875, "invlev_up": 744.5, "invlev_dn": 769.29998779296875, "manhole_up": "manhole_697_generated", "manhole_dn": "manhole_698_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387205.725988702848554, 5861945.987228964455426 ], [ 1387164.745692107127979, 5861917.761652374640107 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E72", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.79998779296875, "elevtn_dn": 764.10003662109375, "invlev_up": 769.29998779296875, "invlev_dn": 761.60003662109375, "manhole_up": "manhole_698_generated", "manhole_dn": "manhole_699_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387164.745692107127979, 5861917.761652374640107 ], [ 1387115.569933785125613, 5861911.215812381356955 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E73", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 764.10003662109375, "elevtn_dn": 764.10003662109375, "invlev_up": 761.60003662109375, "invlev_dn": 761.60003662109375, "manhole_up": "manhole_699_generated", "manhole_dn": "manhole_700_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387115.569933785125613, 5861911.215812381356955 ], [ 1387066.165866439929232, 5861905.273926095105708 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E74", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 764.10003662109375, "elevtn_dn": 747.70001220703125, "invlev_up": 761.60003662109375, "invlev_dn": 745.20001220703125, "manhole_up": "manhole_700_generated", "manhole_dn": "manhole_701_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387066.165866439929232, 5861905.273926095105708 ], [ 1387016.666836149292067, 5861900.238133460283279 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E75", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.70001220703125, "elevtn_dn": 747.70001220703125, "invlev_up": 745.20001220703125, "invlev_dn": 745.20001220703125, "manhole_up": "manhole_701_generated", "manhole_dn": "manhole_702_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387016.666836149292067, 5861900.238133460283279 ], [ 1386975.698310127714649, 5861874.842493440955877 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E76", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.70001220703125, "elevtn_dn": 739.60003662109375, "invlev_up": 745.20001220703125, "invlev_dn": 737.10003662109375, "manhole_up": "manhole_702_generated", "manhole_dn": "manhole_703_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386975.698310127714649, 5861874.842493440955877 ], [ 1386937.286019780673087, 5861843.21080310922116 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E77", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 739.60003662109375, "elevtn_dn": 739.60003662109375, "invlev_up": 737.10003662109375, "invlev_dn": 737.10003662109375, "manhole_up": "manhole_703_generated", "manhole_dn": "manhole_704_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386937.286019780673087, 5861843.21080310922116 ], [ 1386898.873729433864355, 5861811.579112778417766 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E78", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 739.60003662109375, "elevtn_dn": 755.20001220703125, "invlev_up": 737.10003662109375, "invlev_dn": 752.70001220703125, "manhole_up": "manhole_704_generated", "manhole_dn": "manhole_705_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386898.873729433864355, 5861811.579112778417766 ], [ 1386860.461439087055624, 5861779.947422447614372 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E79", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.20001220703125, "elevtn_dn": 745.29998779296875, "invlev_up": 752.70001220703125, "invlev_dn": 742.79998779296875, "manhole_up": "manhole_705_generated", "manhole_dn": "manhole_706_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386860.461439087055624, 5861779.947422447614372 ], [ 1386822.049148740014061, 5861748.315732115879655 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E80", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 745.29998779296875, "elevtn_dn": 745.29998779296875, "invlev_up": 742.79998779296875, "invlev_dn": 742.79998779296875, "manhole_up": "manhole_706_generated", "manhole_dn": "manhole_707_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386822.049148740014061, 5861748.315732115879655 ], [ 1386774.418702265014872, 5861733.958941764198244 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E81", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 745.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 742.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_707_generated", "manhole_dn": "manhole_708_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386774.418702265014872, 5861733.958941764198244 ], [ 1386726.75721522886306, 5861719.660321676172316 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E82", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_708_generated", "manhole_dn": "manhole_709_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386726.75721522886306, 5861719.660321676172316 ], [ 1386681.211287560872734, 5861700.510515534318984 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E83", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 777.9000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_709_generated", "manhole_dn": "manhole_710_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386681.211287560872734, 5861700.510515534318984 ], [ 1386655.081909105414525, 5861659.807657876051962 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E84", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 758.79998779296875, "invlev_up": 775.4000244140625, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_710_generated", "manhole_dn": "manhole_711_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386655.081909105414525, 5861659.807657876051962 ], [ 1386647.41175345890224, 5861610.757949161343277 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E85", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_711_generated", "manhole_dn": "manhole_712_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386647.41175345890224, 5861610.757949161343277 ], [ 1386641.745189253240824, 5861561.363539570011199 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E86", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 732.4000244140625, "invlev_up": 756.29998779296875, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_712_generated", "manhole_dn": "manhole_713_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386641.745189253240824, 5861561.363539570011199 ], [ 1386642.37134926696308, 5861511.607376066967845 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E87", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_713_generated", "manhole_dn": "manhole_714_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386642.37134926696308, 5861511.607376066967845 ], [ 1386642.997509280918166, 5861461.851212563924491 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E88", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_714_generated", "manhole_dn": "manhole_715_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386642.997509280918166, 5861461.851212563924491 ], [ 1386643.623669294640422, 5861412.09504906181246 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E89", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 724.29998779296875, "invlev_up": 729.9000244140625, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_715_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386643.623669294640422, 5861412.09504906181246 ], [ 1386648.271799877518788, 5861347.644815167412162 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_35_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_35", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_35", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_716_generated", "manhole_dn": "manhole_717_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386060.978602184914052, 5859873.390328846871853 ], [ 1386078.54455375042744, 5859857.065600479952991 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_35_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_35", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_35", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_717_generated", "manhole_dn": "manhole_718_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386078.54455375042744, 5859857.065600479952991 ], [ 1386079.86695942771621, 5859885.500408614054322 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_36_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_36", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_36", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_719_generated", "manhole_dn": "manhole_716_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386030.926458492642269, 5859869.881591100245714 ], [ 1386060.978602184914052, 5859873.390328846871853 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_37_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_37", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_37", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_720_generated", "manhole_dn": "manhole_716_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386043.381105761509389, 5859908.11929196305573 ], [ 1386060.978602184914052, 5859873.390328846871853 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_38_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_38", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_718_generated", "manhole_dn": "manhole_721_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386079.86695942771621, 5859885.500408614054322 ], [ 1386081.40363402524963, 5859934.756705570034683 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_38_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_38", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_721_generated", "manhole_dn": "manhole_722_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386081.40363402524963, 5859934.756705570034683 ], [ 1386080.471781946951523, 5859983.948014200665057 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_38_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_38", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 756.5, "invlev_up": 763.79998779296875, "invlev_dn": 754.0, "manhole_up": "manhole_722_generated", "manhole_dn": "manhole_723_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386080.471781946951523, 5859983.948014200665057 ], [ 1386081.101269942475483, 5860033.01989212166518 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_39_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_39", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_718_generated", "manhole_dn": "manhole_724_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386079.86695942771621, 5859885.500408614054322 ], [ 1386051.415038994979113, 5859913.714703594334424 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_39_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_39", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_724_generated", "manhole_dn": "manhole_725_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386051.415038994979113, 5859913.714703594334424 ], [ 1386056.753747603856027, 5859949.43277302198112 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_39_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_39", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_725_generated", "manhole_dn": "manhole_726_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386056.753747603856027, 5859949.43277302198112 ], [ 1386070.153564189793542, 5859990.873222404159606 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_39_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_39", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 756.5, "invlev_up": 763.79998779296875, "invlev_dn": 754.0, "manhole_up": "manhole_726_generated", "manhole_dn": "manhole_723_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386070.153564189793542, 5859990.873222404159606 ], [ 1386081.101269942475483, 5860033.01989212166518 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.5, "elevtn_dn": 756.5, "invlev_up": 754.0, "invlev_dn": 754.0, "manhole_up": "manhole_723_generated", "manhole_dn": "manhole_727_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386081.101269942475483, 5860033.01989212166518 ], [ 1386095.159510504920036, 5860079.476792480796576 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.5, "elevtn_dn": 720.29998779296875, "invlev_up": 754.0, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_727_generated", "manhole_dn": "manhole_728_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386095.159510504920036, 5860079.476792480796576 ], [ 1386119.249574675457552, 5860122.285581497475505 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_728_generated", "manhole_dn": "manhole_729_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386119.249574675457552, 5860122.285581497475505 ], [ 1386143.813145637512207, 5860164.822058788500726 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 732.5, "invlev_up": 717.79998779296875, "invlev_dn": 730.0, "manhole_up": "manhole_729_generated", "manhole_dn": "manhole_730_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386143.813145637512207, 5860164.822058788500726 ], [ 1386168.698389830067754, 5860207.173543182201684 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.5, "elevtn_dn": 732.5, "invlev_up": 730.0, "invlev_dn": 730.0, "manhole_up": "manhole_730_generated", "manhole_dn": "manhole_731_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386168.698389830067754, 5860207.173543182201684 ], [ 1386190.960878706537187, 5860250.914158629253507 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.5, "elevtn_dn": 720.29998779296875, "invlev_up": 730.0, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_731_generated", "manhole_dn": "manhole_732_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386190.960878706537187, 5860250.914158629253507 ], [ 1386212.013376480899751, 5860295.295640649273992 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 729.10003662109375, "invlev_up": 717.79998779296875, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_732_generated", "manhole_dn": "manhole_733_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386212.013376480899751, 5860295.295640649273992 ], [ 1386233.065874255495146, 5860339.677122670225799 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 729.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_733_generated", "manhole_dn": "manhole_734_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386233.065874255495146, 5860339.677122670225799 ], [ 1386254.118372030090541, 5860384.058604690246284 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E8", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 729.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_734_generated", "manhole_dn": "manhole_735_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386254.118372030090541, 5860384.058604690246284 ], [ 1386270.265550139825791, 5860430.368606903590262 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E9", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 746.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 743.60003662109375, "manhole_up": "manhole_735_generated", "manhole_dn": "manhole_736_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386270.265550139825791, 5860430.368606903590262 ], [ 1386284.690116602927446, 5860477.310510716401041 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E10", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 746.10003662109375, "elevtn_dn": 746.10003662109375, "invlev_up": 743.60003662109375, "invlev_dn": 743.60003662109375, "manhole_up": "manhole_736_generated", "manhole_dn": "manhole_737_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386284.690116602927446, 5860477.310510716401041 ], [ 1386295.943752367515117, 5860525.125563691370189 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E11", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 746.10003662109375, "elevtn_dn": 720.29998779296875, "invlev_up": 743.60003662109375, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_737_generated", "manhole_dn": "manhole_738_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386295.943752367515117, 5860525.125563691370189 ], [ 1386307.197388132335618, 5860572.940616665408015 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E12", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_738_generated", "manhole_dn": "manhole_739_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386307.197388132335618, 5860572.940616665408015 ], [ 1386318.451023896923289, 5860620.755669640377164 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E13", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_739_generated", "manhole_dn": "manhole_740_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386318.451023896923289, 5860620.755669640377164 ], [ 1386329.704659661510959, 5860668.57072261441499 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E14", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 737.60003662109375, "invlev_up": 717.79998779296875, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_740_generated", "manhole_dn": "manhole_741_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386329.704659661510959, 5860668.57072261441499 ], [ 1386340.95829542633146, 5860716.385775589384139 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E15", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 737.60003662109375, "invlev_up": 735.10003662109375, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_741_generated", "manhole_dn": "manhole_742_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386340.95829542633146, 5860716.385775589384139 ], [ 1386352.211931190919131, 5860764.200828563421965 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E16", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 737.60003662109375, "invlev_up": 735.10003662109375, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_742_generated", "manhole_dn": "manhole_743_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386352.211931190919131, 5860764.200828563421965 ], [ 1386365.771370212780312, 5860811.365820310078561 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E17", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 744.5, "invlev_up": 735.10003662109375, "invlev_dn": 742.0, "manhole_up": "manhole_743_generated", "manhole_dn": "manhole_744_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386365.771370212780312, 5860811.365820310078561 ], [ 1386381.150273493025452, 5860858.017861452884972 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E18", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 744.5, "elevtn_dn": 724.29998779296875, "invlev_up": 742.0, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_744_generated", "manhole_dn": "manhole_745_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386381.150273493025452, 5860858.017861452884972 ], [ 1386398.399082327727228, 5860903.951519219204783 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E19", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_745_generated", "manhole_dn": "manhole_746_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386398.399082327727228, 5860903.951519219204783 ], [ 1386418.211523674428463, 5860948.90027645137161 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E20", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_746_generated", "manhole_dn": "manhole_747_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386418.211523674428463, 5860948.90027645137161 ], [ 1386441.67837643600069, 5860992.033180211670697 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E21", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_747_generated", "manhole_dn": "manhole_748_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386441.67837643600069, 5860992.033180211670697 ], [ 1386465.536530936835334, 5861034.971648660488427 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E22", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.9000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 722.4000244140625, "manhole_up": "manhole_748_generated", "manhole_dn": "manhole_749_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386465.536530936835334, 5861034.971648660488427 ], [ 1386489.394685437437147, 5861077.910117109306157 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E23", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.9000244140625, "elevtn_dn": 724.29998779296875, "invlev_up": 722.4000244140625, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_749_generated", "manhole_dn": "manhole_750_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386489.394685437437147, 5861077.910117109306157 ], [ 1386513.252839938271791, 5861120.848585557192564 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E24", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_750_generated", "manhole_dn": "manhole_751_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386513.252839938271791, 5861120.848585557192564 ], [ 1386537.110994438873604, 5861163.787054006010294 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E25", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_751_generated", "manhole_dn": "manhole_752_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386537.110994438873604, 5861163.787054006010294 ], [ 1386560.969148939708248, 5861206.725522454828024 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E26", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_752_generated", "manhole_dn": "manhole_753_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386560.969148939708248, 5861206.725522454828024 ], [ 1386584.827303440310061, 5861249.663990902714431 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E27", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_753_generated", "manhole_dn": "manhole_754_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386584.827303440310061, 5861249.663990902714431 ], [ 1386607.696082097478211, 5861293.105181481689215 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E28", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_754_generated", "manhole_dn": "manhole_755_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386607.696082097478211, 5861293.105181481689215 ], [ 1386626.999141034670174, 5861338.164890616200864 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E29", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 732.4000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_755_generated", "manhole_dn": "manhole_756_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386626.999141034670174, 5861338.164890616200864 ], [ 1386632.635544582502916, 5861386.242180755361915 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E30", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_756_generated", "manhole_dn": "manhole_757_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386632.635544582502916, 5861386.242180755361915 ], [ 1386628.332881111185998, 5861435.174896763637662 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E31", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_757_generated", "manhole_dn": "manhole_758_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386628.332881111185998, 5861435.174896763637662 ], [ 1386624.030217639869079, 5861484.107612771913409 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E32", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 758.79998779296875, "invlev_up": 729.9000244140625, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_758_generated", "manhole_dn": "manhole_759_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386624.030217639869079, 5861484.107612771913409 ], [ 1386619.72755416855216, 5861533.040328779257834 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E33", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_759_generated", "manhole_dn": "manhole_760_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386619.72755416855216, 5861533.040328779257834 ], [ 1386620.396809899713844, 5861581.843449912965298 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E34", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_760_generated", "manhole_dn": "manhole_761_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386620.396809899713844, 5861581.843449912965298 ], [ 1386627.242796876933426, 5861630.485572309233248 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E35", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 777.9000244140625, "invlev_up": 756.29998779296875, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_761_generated", "manhole_dn": "manhole_762_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386627.242796876933426, 5861630.485572309233248 ], [ 1386633.497009602142498, 5861679.177458625286818 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E36", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 777.9000244140625, "invlev_up": 775.4000244140625, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_762_generated", "manhole_dn": "manhole_763_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386633.497009602142498, 5861679.177458625286818 ], [ 1386633.587326586712152, 5861728.232037586160004 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E37", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 777.9000244140625, "invlev_up": 775.4000244140625, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_763_generated", "manhole_dn": "manhole_764_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386633.587326586712152, 5861728.232037586160004 ], [ 1386628.569951781770214, 5861777.096641942858696 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E38", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 787.0, "invlev_up": 775.4000244140625, "invlev_dn": 784.5, "manhole_up": "manhole_764_generated", "manhole_dn": "manhole_765_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386628.569951781770214, 5861777.096641942858696 ], [ 1386623.552576976828277, 5861825.961246299557388 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 787.0, "elevtn_dn": 787.0, "invlev_up": 784.5, "invlev_dn": 784.5, "manhole_up": "manhole_765_generated", "manhole_dn": "manhole_766_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386623.552576976828277, 5861825.961246299557388 ], [ 1386622.452884682221338, 5861875.377415779046714 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 787.0, "elevtn_dn": 768.0, "invlev_up": 784.5, "invlev_dn": 765.5, "manhole_up": "manhole_766_generated", "manhole_dn": "manhole_767_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386622.452884682221338, 5861875.377415779046714 ], [ 1386630.050831846194342, 5861924.208797036670148 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_767_generated", "manhole_dn": "manhole_768_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386630.050831846194342, 5861924.208797036670148 ], [ 1386645.112437101313844, 5861971.295391816645861 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_768_generated", "manhole_dn": "manhole_769_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386645.112437101313844, 5861971.295391816645861 ], [ 1386663.826805545249954, 5862017.116109635680914 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 729.0, "invlev_up": 765.5, "invlev_dn": 726.5, "manhole_up": "manhole_769_generated", "manhole_dn": "manhole_770_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386663.826805545249954, 5862017.116109635680914 ], [ 1386682.541173989186063, 5862062.93682745564729 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 729.0, "invlev_up": 726.5, "invlev_dn": 726.5, "manhole_up": "manhole_770_generated", "manhole_dn": "manhole_771_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386682.541173989186063, 5862062.93682745564729 ], [ 1386700.357504795538262, 5862109.113540357910097 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 729.0, "invlev_up": 726.5, "invlev_dn": 726.5, "manhole_up": "manhole_771_generated", "manhole_dn": "manhole_772_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386700.357504795538262, 5862109.113540357910097 ], [ 1386718.120609947945923, 5862155.311352676711977 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 724.29998779296875, "invlev_up": 726.5, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_772_generated", "manhole_dn": "manhole_773_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386718.120609947945923, 5862155.311352676711977 ], [ 1386735.883715100120753, 5862201.509164996445179 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E8", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_773_generated", "manhole_dn": "manhole_774_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386735.883715100120753, 5862201.509164996445179 ], [ 1386757.522535112220794, 5862245.993861058726907 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E9", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_774_generated", "manhole_dn": "manhole_775_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386757.522535112220794, 5862245.993861058726907 ], [ 1386779.73098383564502, 5862290.226773838512599 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E10", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_775_generated", "manhole_dn": "manhole_776_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386779.73098383564502, 5862290.226773838512599 ], [ 1386802.545179207576439, 5862334.095372994430363 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E11", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_776_generated", "manhole_dn": "manhole_777_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386802.545179207576439, 5862334.095372994430363 ], [ 1386831.207993831252679, 5862374.446442689746618 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E12", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 737.70001220703125, "invlev_up": 721.79998779296875, "invlev_dn": 735.20001220703125, "manhole_up": "manhole_777_generated", "manhole_dn": "manhole_778_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386831.207993831252679, 5862374.446442689746618 ], [ 1386859.988485741894692, 5862414.708453865721822 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E13", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.70001220703125, "elevtn_dn": 737.70001220703125, "invlev_up": 735.20001220703125, "invlev_dn": 735.20001220703125, "manhole_up": "manhole_778_generated", "manhole_dn": "manhole_779_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386859.988485741894692, 5862414.708453865721822 ], [ 1386891.035651177866384, 5862453.255039785988629 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E14", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.70001220703125, "elevtn_dn": 743.9000244140625, "invlev_up": 735.20001220703125, "invlev_dn": 741.4000244140625, "manhole_up": "manhole_779_generated", "manhole_dn": "manhole_780_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386891.035651177866384, 5862453.255039785988629 ], [ 1386922.082816614070907, 5862491.801625707186759 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E15", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 743.9000244140625, "elevtn_dn": 756.0, "invlev_up": 741.4000244140625, "invlev_dn": 753.5, "manhole_up": "manhole_780_generated", "manhole_dn": "manhole_781_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386922.082816614070907, 5862491.801625707186759 ], [ 1386953.12998205027543, 5862530.348211627453566 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E16", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.0, "elevtn_dn": 756.0, "invlev_up": 753.5, "invlev_dn": 753.5, "manhole_up": "manhole_781_generated", "manhole_dn": "manhole_782_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386953.12998205027543, 5862530.348211627453566 ], [ 1386984.177147486479953, 5862568.894797547720373 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E17", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.0, "elevtn_dn": 761.4000244140625, "invlev_up": 753.5, "invlev_dn": 758.9000244140625, "manhole_up": "manhole_782_generated", "manhole_dn": "manhole_783_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386984.177147486479953, 5862568.894797547720373 ], [ 1387010.83190148579888, 5862610.297833287157118 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E18", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.4000244140625, "elevtn_dn": 761.4000244140625, "invlev_up": 758.9000244140625, "invlev_dn": 758.9000244140625, "manhole_up": "manhole_783_generated", "manhole_dn": "manhole_784_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387010.83190148579888, 5862610.297833287157118 ], [ 1387033.474099110113457, 5862654.310293504968286 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E19", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.4000244140625, "elevtn_dn": 770.5, "invlev_up": 758.9000244140625, "invlev_dn": 768.0, "manhole_up": "manhole_784_generated", "manhole_dn": "manhole_785_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387033.474099110113457, 5862654.310293504968286 ], [ 1387056.116296734428033, 5862698.322753723710775 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E20", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 770.5, "elevtn_dn": 765.29998779296875, "invlev_up": 768.0, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_785_generated", "manhole_dn": "manhole_786_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387056.116296734428033, 5862698.322753723710775 ], [ 1387078.75849435874261, 5862742.335213942453265 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E21", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 765.29998779296875, "invlev_up": 762.79998779296875, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_786_generated", "manhole_dn": "manhole_787_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387078.75849435874261, 5862742.335213942453265 ], [ 1387101.400691983057186, 5862786.347674161195755 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E22", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 765.29998779296875, "invlev_up": 762.79998779296875, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_787_generated", "manhole_dn": "manhole_788_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387101.400691983057186, 5862786.347674161195755 ], [ 1387124.783531384309754, 5862829.966971693560481 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E23", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 764.20001220703125, "invlev_up": 762.79998779296875, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_788_generated", "manhole_dn": "manhole_789_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387124.783531384309754, 5862829.966971693560481 ], [ 1387148.551342260092497, 5862873.381910757161677 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E24", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 764.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_789_generated", "manhole_dn": "manhole_790_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387148.551342260092497, 5862873.381910757161677 ], [ 1387176.029596295906231, 5862914.516764627769589 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E25", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 764.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_790_generated", "manhole_dn": "manhole_791_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387176.029596295906231, 5862914.516764627769589 ], [ 1387204.050833505578339, 5862955.315435893833637 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E26", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 769.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 766.70001220703125, "manhole_up": "manhole_791_generated", "manhole_dn": "manhole_792_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387204.050833505578339, 5862955.315435893833637 ], [ 1387233.152246462181211, 5862995.351338926702738 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E27", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 769.20001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 766.70001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_792_generated", "manhole_dn": "manhole_793_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387233.152246462181211, 5862995.351338926702738 ], [ 1387262.253659419016913, 5863035.387241959571838 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E28", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 770.20001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_793_generated", "manhole_dn": "manhole_794_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387262.253659419016913, 5863035.387241959571838 ], [ 1387289.177211825968698, 5863076.714860137552023 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E29", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 770.20001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_794_generated", "manhole_dn": "manhole_795_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387289.177211825968698, 5863076.714860137552023 ], [ 1387304.666786204557866, 5863123.392671256326139 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E30", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 762.0, "invlev_up": 770.20001220703125, "invlev_dn": 759.5, "manhole_up": "manhole_795_generated", "manhole_dn": "manhole_796_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387304.666786204557866, 5863123.392671256326139 ], [ 1387314.520281337434426, 5863171.895173518918455 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E31", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 777.10003662109375, "invlev_up": 759.5, "invlev_dn": 774.60003662109375, "manhole_up": "manhole_796_generated", "manhole_dn": "manhole_797_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387314.520281337434426, 5863171.895173518918455 ], [ 1387324.142220750683919, 5863220.446013364940882 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E32", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.10003662109375, "elevtn_dn": 780.4000244140625, "invlev_up": 774.60003662109375, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_797_generated", "manhole_dn": "manhole_798_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387324.142220750683919, 5863220.446013364940882 ], [ 1387333.764160163700581, 5863268.996853210031986 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E33", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 780.4000244140625, "invlev_up": 777.9000244140625, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_798_generated", "manhole_dn": "manhole_799_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387333.764160163700581, 5863268.996853210031986 ], [ 1387343.386099576717243, 5863317.547693055123091 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E34", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 780.4000244140625, "invlev_up": 777.9000244140625, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_799_generated", "manhole_dn": "manhole_800_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387343.386099576717243, 5863317.547693055123091 ], [ 1387353.008038989733905, 5863366.098532900214195 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E35", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 762.0, "invlev_up": 777.9000244140625, "invlev_dn": 759.5, "manhole_up": "manhole_800_generated", "manhole_dn": "manhole_801_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387353.008038989733905, 5863366.098532900214195 ], [ 1387364.066297837067395, 5863414.311534740030766 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E36", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_801_generated", "manhole_dn": "manhole_802_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387364.066297837067395, 5863414.311534740030766 ], [ 1387381.839409928303212, 5863460.427046488039196 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E37", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_802_generated", "manhole_dn": "manhole_803_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387381.839409928303212, 5863460.427046488039196 ], [ 1387403.429578960640356, 5863504.96100580971688 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E38", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_803_generated", "manhole_dn": "manhole_804_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387403.429578960640356, 5863504.96100580971688 ], [ 1387425.140452897874638, 5863549.440256260335445 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E39", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_804_generated", "manhole_dn": "manhole_805_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387425.140452897874638, 5863549.440256260335445 ], [ 1387446.851326835108921, 5863593.91950671095401 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E40", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_805_generated", "manhole_dn": "manhole_806_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387446.851326835108921, 5863593.91950671095401 ], [ 1387467.528695637593046, 5863638.888379830867052 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E41", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 774.5, "invlev_up": 759.5, "invlev_dn": 772.0, "manhole_up": "manhole_806_generated", "manhole_dn": "manhole_807_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387467.528695637593046, 5863638.888379830867052 ], [ 1387488.196078018052503, 5863683.861984014511108 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E42", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 774.5, "elevtn_dn": 762.0, "invlev_up": 772.0, "invlev_dn": 759.5, "manhole_up": "manhole_807_generated", "manhole_dn": "manhole_808_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387488.196078018052503, 5863683.861984014511108 ], [ 1387508.863468252588063, 5863728.835584589280188 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E43", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_808_generated", "manhole_dn": "manhole_809_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387508.863468252588063, 5863728.835584589280188 ], [ 1387529.53130904212594, 5863773.808978110551834 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E44", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_809_generated", "manhole_dn": "manhole_810_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387529.53130904212594, 5863773.808978110551834 ], [ 1387553.168002701364458, 5863817.17347530182451 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E45", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_810_generated", "manhole_dn": "manhole_811_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387553.168002701364458, 5863817.17347530182451 ], [ 1387579.562712850514799, 5863859.043333718553185 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E46", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 777.0, "invlev_up": 759.5, "invlev_dn": 774.5, "manhole_up": "manhole_811_generated", "manhole_dn": "manhole_812_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387579.562712850514799, 5863859.043333718553185 ], [ 1387605.957422999665141, 5863900.913192136213183 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E47", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.0, "elevtn_dn": 762.0, "invlev_up": 774.5, "invlev_dn": 759.5, "manhole_up": "manhole_812_generated", "manhole_dn": "manhole_813_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387605.957422999665141, 5863900.913192136213183 ], [ 1387632.352133149048313, 5863942.783050553873181 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E48", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_813_generated", "manhole_dn": "manhole_814_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387632.352133149048313, 5863942.783050553873181 ], [ 1387658.746843298198655, 5863984.652908970601857 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E49", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_814_generated", "manhole_dn": "manhole_815_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387658.746843298198655, 5863984.652908970601857 ], [ 1387685.893106181640178, 5864026.029537551105022 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E50", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_815_generated", "manhole_dn": "manhole_816_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387685.893106181640178, 5864026.029537551105022 ], [ 1387711.231136992340907, 5864068.42725711222738 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E51", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_816_generated", "manhole_dn": "manhole_817_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387711.231136992340907, 5864068.42725711222738 ], [ 1387731.020947323646396, 5864113.414904261007905 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E52", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_817_generated", "manhole_dn": "manhole_818_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387731.020947323646396, 5864113.414904261007905 ], [ 1387737.361907477490604, 5864162.342261835932732 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E53", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_818_generated", "manhole_dn": "manhole_819_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387737.361907477490604, 5864162.342261835932732 ], [ 1387732.727565656881779, 5864211.475179814733565 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E54", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_819_generated", "manhole_dn": "manhole_820_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387732.727565656881779, 5864211.475179814733565 ], [ 1387717.67884943424724, 5864258.627082298509777 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E55", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_820_generated", "manhole_dn": "manhole_821_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387717.67884943424724, 5864258.627082298509777 ], [ 1387709.67210421175696, 5864307.23127611912787 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E56", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 768.0, "invlev_up": 759.5, "invlev_dn": 765.5, "manhole_up": "manhole_821_generated", "manhole_dn": "manhole_822_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387709.67210421175696, 5864307.23127611912787 ], [ 1387707.11288084089756, 5864356.66017600055784 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E57", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_822_generated", "manhole_dn": "manhole_823_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387707.11288084089756, 5864356.66017600055784 ], [ 1387709.591797993984073, 5864406.012949175201356 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E58", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_823_generated", "manhole_dn": "manhole_824_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387709.591797993984073, 5864406.012949175201356 ], [ 1387713.643261310644448, 5864455.341961052268744 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E59", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 777.20001220703125, "invlev_up": 765.5, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_824_generated", "manhole_dn": "manhole_825_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387713.643261310644448, 5864455.341961052268744 ], [ 1387715.877521668095142, 5864504.642317942343652 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E60", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 774.70001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_825_generated", "manhole_dn": "manhole_826_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387715.877521668095142, 5864504.642317942343652 ], [ 1387708.68023270717822, 5864553.426558391191065 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E61", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 774.70001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_826_generated", "manhole_dn": "manhole_827_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387708.68023270717822, 5864553.426558391191065 ], [ 1387690.790250770282, 5864599.575386263430119 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E62", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 810.60003662109375, "invlev_up": 774.70001220703125, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_827_generated", "manhole_dn": "manhole_828_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387690.790250770282, 5864599.575386263430119 ], [ 1387672.900268833618611, 5864645.724214136600494 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E63", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 810.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_828_generated", "manhole_dn": "manhole_829_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387672.900268833618611, 5864645.724214136600494 ], [ 1387659.931900478899479, 5864692.98388583958149 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E64", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 810.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_829_generated", "manhole_dn": "manhole_830_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387659.931900478899479, 5864692.98388583958149 ], [ 1387659.223570322152227, 5864742.029465307481587 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E65", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_830_generated", "manhole_dn": "manhole_831_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387659.223570322152227, 5864742.029465307481587 ], [ 1387675.926896508783102, 5864788.273513910360634 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E66", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 774.10003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 771.60003662109375, "manhole_up": "manhole_831_generated", "manhole_dn": "manhole_832_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387675.926896508783102, 5864788.273513910360634 ], [ 1387702.296291569946334, 5864830.159320239908993 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E67", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 774.10003662109375, "elevtn_dn": 774.10003662109375, "invlev_up": 771.60003662109375, "invlev_dn": 771.60003662109375, "manhole_up": "manhole_832_generated", "manhole_dn": "manhole_833_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387702.296291569946334, 5864830.159320239908993 ], [ 1387728.665686630876735, 5864872.045126569457352 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E68", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 774.10003662109375, "elevtn_dn": 782.5, "invlev_up": 771.60003662109375, "invlev_dn": 780.0, "manhole_up": "manhole_833_generated", "manhole_dn": "manhole_834_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387728.665686630876735, 5864872.045126569457352 ], [ 1387751.608185108983889, 5864915.528788692317903 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E69", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 782.5, "invlev_up": 780.0, "invlev_dn": 780.0, "manhole_up": "manhole_834_generated", "manhole_dn": "manhole_835_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387751.608185108983889, 5864915.528788692317903 ], [ 1387766.741664502769709, 5864962.653554677963257 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E70", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 782.5, "invlev_up": 780.0, "invlev_dn": 780.0, "manhole_up": "manhole_835_generated", "manhole_dn": "manhole_836_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387766.741664502769709, 5864962.653554677963257 ], [ 1387778.99191950308159, 5865010.246724016033113 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E71", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 820.20001220703125, "invlev_up": 780.0, "invlev_dn": 817.70001220703125, "manhole_up": "manhole_836_generated", "manhole_dn": "manhole_837_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387778.99191950308159, 5865010.246724016033113 ], [ 1387779.554608268430457, 5865059.738633952103555 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E72", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 820.20001220703125, "elevtn_dn": 820.20001220703125, "invlev_up": 817.70001220703125, "invlev_dn": 817.70001220703125, "manhole_up": "manhole_837_generated", "manhole_dn": "manhole_838_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387779.554608268430457, 5865059.738633952103555 ], [ 1387780.117297033779323, 5865109.230543887242675 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E73", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 820.20001220703125, "elevtn_dn": 834.60003662109375, "invlev_up": 817.70001220703125, "invlev_dn": 832.10003662109375, "manhole_up": "manhole_838_generated", "manhole_dn": "manhole_839_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387780.117297033779323, 5865109.230543887242675 ], [ 1387782.917817069217563, 5865158.566991245374084 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E74", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 834.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 832.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_839_generated", "manhole_dn": "manhole_840_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387782.917817069217563, 5865158.566991245374084 ], [ 1387789.203931836877018, 5865207.661293652839959 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E75", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_840_generated", "manhole_dn": "manhole_841_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387789.203931836877018, 5865207.661293652839959 ], [ 1387795.490046604769304, 5865256.755596060305834 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E76", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_841_generated", "manhole_dn": "manhole_842_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387795.490046604769304, 5865256.755596060305834 ], [ 1387804.549934879876673, 5865305.332479531876743 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E77", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 809.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_842_generated", "manhole_dn": "manhole_843_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387804.549934879876673, 5865305.332479531876743 ], [ 1387816.386747075244784, 5865353.391356389038265 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E78", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 809.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_843_generated", "manhole_dn": "manhole_844_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387816.386747075244784, 5865353.391356389038265 ], [ 1387828.223559270845726, 5865401.450233246199787 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E79", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 802.5, "invlev_up": 809.10003662109375, "invlev_dn": 800.0, "manhole_up": "manhole_844_generated", "manhole_dn": "manhole_845_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387828.223559270845726, 5865401.450233246199787 ], [ 1387842.96627543354407, 5865448.679594250395894 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E80", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 802.5, "invlev_up": 800.0, "invlev_dn": 800.0, "manhole_up": "manhole_845_generated", "manhole_dn": "manhole_846_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387842.96627543354407, 5865448.679594250395894 ], [ 1387858.283513206522912, 5865495.744953005574644 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E81", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 802.5, "invlev_up": 800.0, "invlev_dn": 800.0, "manhole_up": "manhole_846_generated", "manhole_dn": "manhole_847_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387858.283513206522912, 5865495.744953005574644 ], [ 1387872.788357679266483, 5865543.026506381109357 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E82", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 778.20001220703125, "invlev_up": 800.0, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_847_generated", "manhole_dn": "manhole_848_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387872.788357679266483, 5865543.026506381109357 ], [ 1387882.890574953285977, 5865591.479689701460302 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E83", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_848_generated", "manhole_dn": "manhole_849_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387882.890574953285977, 5865591.479689701460302 ], [ 1387892.992792227305472, 5865639.932873022742569 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E84", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_849_generated", "manhole_dn": "manhole_850_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387892.992792227305472, 5865639.932873022742569 ], [ 1387903.095009501324967, 5865688.386056343093514 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E85", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_850_generated", "manhole_dn": "manhole_851_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387903.095009501324967, 5865688.386056343093514 ], [ 1387913.197226775344461, 5865736.839239663444459 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_42_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 830.9000244140625, "invlev_up": 828.4000244140625, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_852_generated", "manhole_dn": "manhole_853_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387767.438602478476241, 5866395.894650792703032 ], [ 1387758.181959156645462, 5866444.388786932453513 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_42_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 830.9000244140625, "invlev_up": 828.4000244140625, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_853_generated", "manhole_dn": "manhole_854_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387758.181959156645462, 5866444.388786932453513 ], [ 1387748.925315835047513, 5866492.882923071272671 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_42_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 816.5, "invlev_up": 828.4000244140625, "invlev_dn": 814.0, "manhole_up": "manhole_854_generated", "manhole_dn": "manhole_855_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387748.925315835047513, 5866492.882923071272671 ], [ 1387739.668672513216734, 5866541.377059211023152 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_42_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.5, "elevtn_dn": 816.5, "invlev_up": 814.0, "invlev_dn": 814.0, "manhole_up": "manhole_855_generated", "manhole_dn": "manhole_856_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387739.668672513216734, 5866541.377059211023152 ], [ 1387730.412029191618785, 5866589.87119534984231 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_42_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.5, "elevtn_dn": 816.10003662109375, "invlev_up": 814.0, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_856_generated", "manhole_dn": "manhole_857_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387730.412029191618785, 5866589.87119534984231 ], [ 1387721.155385869788006, 5866638.365331489592791 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_42_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 816.10003662109375, "invlev_up": 813.60003662109375, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_857_generated", "manhole_dn": "manhole_858_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387721.155385869788006, 5866638.365331489592791 ], [ 1387711.868742506252602, 5866686.853722332976758 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_42_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 816.10003662109375, "invlev_up": 813.60003662109375, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_858_generated", "manhole_dn": "manhole_859_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387711.868742506252602, 5866686.853722332976758 ], [ 1387702.553355348296463, 5866735.336608462966979 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_42_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 802.4000244140625, "invlev_up": 813.60003662109375, "invlev_dn": 799.9000244140625, "manhole_up": "manhole_859_generated", "manhole_dn": "manhole_860_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387702.553355348296463, 5866735.336608462966979 ], [ 1387692.161796326050535, 5866783.420620376244187 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_43_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_43", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_43", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_861_generated", "manhole_dn": "manhole_862_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387809.534624515566975, 5866309.639251782558858 ], [ 1387788.486613497138023, 5866352.766951287165284 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_43_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_43", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_43", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 830.9000244140625, "invlev_up": 803.70001220703125, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_862_generated", "manhole_dn": "manhole_852_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387788.486613497138023, 5866352.766951287165284 ], [ 1387767.438602478476241, 5866395.894650792703032 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_44_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 840.10003662109375, "invlev_up": 828.4000244140625, "invlev_dn": 837.60003662109375, "manhole_up": "manhole_852_generated", "manhole_dn": "manhole_863_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387767.438602478476241, 5866395.894650792703032 ], [ 1387774.73306847945787, 5866351.644692087545991 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_44_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 840.10003662109375, "elevtn_dn": 806.20001220703125, "invlev_up": 837.60003662109375, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_863_generated", "manhole_dn": "manhole_864_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387774.73306847945787, 5866351.644692087545991 ], [ 1387787.219046234386042, 5866308.756401930935681 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_44_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_864_generated", "manhole_dn": "manhole_865_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387787.219046234386042, 5866308.756401930935681 ], [ 1387802.581935805035755, 5866266.622689731419086 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_44_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_865_generated", "manhole_dn": "manhole_866_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387802.581935805035755, 5866266.622689731419086 ], [ 1387818.989883717847988, 5866224.886323318816721 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_44_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_866_generated", "manhole_dn": "manhole_867_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387818.989883717847988, 5866224.886323318816721 ], [ 1387838.767447788733989, 5866184.784887914545834 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_44_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_867_generated", "manhole_dn": "manhole_868_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387838.767447788733989, 5866184.784887914545834 ], [ 1387862.375427621416748, 5866146.679679537191987 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_44_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 803.9000244140625, "invlev_up": 825.20001220703125, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_868_generated", "manhole_dn": "manhole_869_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387862.375427621416748, 5866146.679679537191987 ], [ 1387890.316308293025941, 5866111.904927220195532 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_44_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_869_generated", "manhole_dn": "manhole_870_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387890.316308293025941, 5866111.904927220195532 ], [ 1387932.086585889104754, 5866099.149365295656025 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_45_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_45", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_871_generated", "manhole_dn": "manhole_872_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387931.614702571649104, 5866170.542120457626879 ], [ 1387899.497387683717534, 5866203.806988564319909 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_45_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_45", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 806.20001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_872_generated", "manhole_dn": "manhole_873_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387899.497387683717534, 5866203.806988564319909 ], [ 1387869.509799961000681, 5866239.084409636445343 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_45_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_45", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_873_generated", "manhole_dn": "manhole_874_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387869.509799961000681, 5866239.084409636445343 ], [ 1387839.522212238283828, 5866274.361830709502101 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_45_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_45", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_874_generated", "manhole_dn": "manhole_861_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387839.522212238283828, 5866274.361830709502101 ], [ 1387809.534624515566975, 5866309.639251782558858 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_46_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_46", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_870_generated", "manhole_dn": "manhole_875_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387932.086585889104754, 5866099.149365295656025 ], [ 1387908.367353544337675, 5866141.903963415883482 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_46_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_46", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_875_generated", "manhole_dn": "manhole_876_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387908.367353544337675, 5866141.903963415883482 ], [ 1387876.955022902460769, 5866179.987773489207029 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_46_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_46", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 827.70001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_876_generated", "manhole_dn": "manhole_877_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387876.955022902460769, 5866179.987773489207029 ], [ 1387847.458594153402373, 5866219.470102892257273 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_46_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_46", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_877_generated", "manhole_dn": "manhole_878_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387847.458594153402373, 5866219.470102892257273 ], [ 1387823.639855962945148, 5866262.662997540086508 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_46_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_46", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_878_generated", "manhole_dn": "manhole_861_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387823.639855962945148, 5866262.662997540086508 ], [ 1387809.534624515566975, 5866309.639251782558858 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_47_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_47", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_879_generated", "manhole_dn": "manhole_880_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.443674022099003, 5865845.093254727311432 ], [ 1387943.318034203490242, 5865887.628139751963317 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_47_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_47", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_880_generated", "manhole_dn": "manhole_881_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387943.318034203490242, 5865887.628139751963317 ], [ 1387946.009428307646886, 5865930.175072746351361 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_47_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_47", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 816.70001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_881_generated", "manhole_dn": "manhole_882_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387946.009428307646886, 5865930.175072746351361 ], [ 1387948.700822412036359, 5865972.722005739808083 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_47_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_47", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_882_generated", "manhole_dn": "manhole_883_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387948.700822412036359, 5865972.722005739808083 ], [ 1387944.872250664513558, 5866015.105105520226061 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_47_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_47", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_883_generated", "manhole_dn": "manhole_884_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387944.872250664513558, 5866015.105105520226061 ], [ 1387940.047370131826028, 5866057.463170127011836 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_47_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_47", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 803.9000244140625, "invlev_up": 814.20001220703125, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_884_generated", "manhole_dn": "manhole_870_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.047370131826028, 5866057.463170127011836 ], [ 1387932.086585889104754, 5866099.149365295656025 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_48_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_48", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_48", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 786.29998779296875, "invlev_up": 801.4000244140625, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_870_generated", "manhole_dn": "manhole_885_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387932.086585889104754, 5866099.149365295656025 ], [ 1387975.279995472636074, 5866107.425722245126963 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E125", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 909.5, "elevtn_dn": 910.4000244140625, "invlev_up": 907.0, "invlev_dn": 907.9000244140625, "manhole_up": "manhole_886_generated", "manhole_dn": "manhole_887_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392926.966794768813998, 5866808.501405037939548 ], [ 1392879.417931769276038, 5866793.491589142940938 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E126", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 910.4000244140625, "elevtn_dn": 910.4000244140625, "invlev_up": 907.9000244140625, "invlev_dn": 907.9000244140625, "manhole_up": "manhole_887_generated", "manhole_dn": "manhole_888_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392879.417931769276038, 5866793.491589142940938 ], [ 1392831.869068769738078, 5866778.481773247942328 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E127", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 910.4000244140625, "elevtn_dn": 865.0, "invlev_up": 907.9000244140625, "invlev_dn": 862.5, "manhole_up": "manhole_888_generated", "manhole_dn": "manhole_889_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392831.869068769738078, 5866778.481773247942328 ], [ 1392784.320205770200118, 5866763.471957352943718 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E128", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 865.0, "elevtn_dn": 865.0, "invlev_up": 862.5, "invlev_dn": 862.5, "manhole_up": "manhole_889_generated", "manhole_dn": "manhole_890_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392784.320205770200118, 5866763.471957352943718 ], [ 1392736.771342770429328, 5866748.462141457945108 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E129", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 865.0, "elevtn_dn": 878.4000244140625, "invlev_up": 862.5, "invlev_dn": 875.9000244140625, "manhole_up": "manhole_890_generated", "manhole_dn": "manhole_891_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392736.771342770429328, 5866748.462141457945108 ], [ 1392689.222479770891368, 5866733.452325562946498 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E130", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 878.4000244140625, "elevtn_dn": 878.4000244140625, "invlev_up": 875.9000244140625, "invlev_dn": 875.9000244140625, "manhole_up": "manhole_891_generated", "manhole_dn": "manhole_892_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392689.222479770891368, 5866733.452325562946498 ], [ 1392641.673616771353409, 5866718.442509667947888 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E131", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 878.4000244140625, "elevtn_dn": 904.9000244140625, "invlev_up": 875.9000244140625, "invlev_dn": 902.4000244140625, "manhole_up": "manhole_892_generated", "manhole_dn": "manhole_893_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392641.673616771353409, 5866718.442509667947888 ], [ 1392594.124753771815449, 5866703.432693773880601 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E132", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 904.9000244140625, "elevtn_dn": 904.9000244140625, "invlev_up": 902.4000244140625, "invlev_dn": 902.4000244140625, "manhole_up": "manhole_893_generated", "manhole_dn": "manhole_894_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392594.124753771815449, 5866703.432693773880601 ], [ 1392546.575890772277489, 5866688.422877878881991 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E133", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 904.9000244140625, "elevtn_dn": 931.5, "invlev_up": 902.4000244140625, "invlev_dn": 929.0, "manhole_up": "manhole_894_generated", "manhole_dn": "manhole_895_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392546.575890772277489, 5866688.422877878881991 ], [ 1392499.02702777273953, 5866673.413061983883381 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E134", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 931.5, "elevtn_dn": 931.5, "invlev_up": 929.0, "invlev_dn": 929.0, "manhole_up": "manhole_895_generated", "manhole_dn": "manhole_896_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392499.02702777273953, 5866673.413061983883381 ], [ 1392451.47816477320157, 5866658.403246088884771 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E135", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 931.5, "elevtn_dn": 926.29998779296875, "invlev_up": 929.0, "invlev_dn": 923.79998779296875, "manhole_up": "manhole_896_generated", "manhole_dn": "manhole_897_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392451.47816477320157, 5866658.403246088884771 ], [ 1392403.92930177366361, 5866643.393430193886161 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E136", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 926.29998779296875, "elevtn_dn": 849.79998779296875, "invlev_up": 923.79998779296875, "invlev_dn": 847.29998779296875, "manhole_up": "manhole_897_generated", "manhole_dn": "manhole_898_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392403.92930177366361, 5866643.393430193886161 ], [ 1392356.380438774125651, 5866628.383614298887551 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E137", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 849.79998779296875, "elevtn_dn": 875.20001220703125, "invlev_up": 847.29998779296875, "invlev_dn": 872.70001220703125, "manhole_up": "manhole_898_generated", "manhole_dn": "manhole_899_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392356.380438774125651, 5866628.383614298887551 ], [ 1392308.831575774587691, 5866613.373798403888941 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E138", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 875.20001220703125, "elevtn_dn": 875.20001220703125, "invlev_up": 872.70001220703125, "invlev_dn": 872.70001220703125, "manhole_up": "manhole_899_generated", "manhole_dn": "manhole_900_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392308.831575774587691, 5866613.373798403888941 ], [ 1392261.282712775049731, 5866598.363982509821653 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E139", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 875.20001220703125, "elevtn_dn": 928.10003662109375, "invlev_up": 872.70001220703125, "invlev_dn": 925.60003662109375, "manhole_up": "manhole_900_generated", "manhole_dn": "manhole_901_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392261.282712775049731, 5866598.363982509821653 ], [ 1392213.733849775511771, 5866583.354166614823043 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E140", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 928.10003662109375, "elevtn_dn": 928.10003662109375, "invlev_up": 925.60003662109375, "invlev_dn": 925.60003662109375, "manhole_up": "manhole_901_generated", "manhole_dn": "manhole_902_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392213.733849775511771, 5866583.354166614823043 ], [ 1392166.184986775973812, 5866568.344350719824433 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E141", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 928.10003662109375, "elevtn_dn": 936.79998779296875, "invlev_up": 925.60003662109375, "invlev_dn": 934.29998779296875, "manhole_up": "manhole_902_generated", "manhole_dn": "manhole_903_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392166.184986775973812, 5866568.344350719824433 ], [ 1392119.234377897810191, 5866551.59017149079591 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E142", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 936.79998779296875, "elevtn_dn": 936.79998779296875, "invlev_up": 934.29998779296875, "invlev_dn": 934.29998779296875, "manhole_up": "manhole_903_generated", "manhole_dn": "manhole_904_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392119.234377897810191, 5866551.59017149079591 ], [ 1392072.481987217208371, 5866534.25803626794368 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E143", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 936.79998779296875, "elevtn_dn": 929.79998779296875, "invlev_up": 934.29998779296875, "invlev_dn": 927.29998779296875, "manhole_up": "manhole_904_generated", "manhole_dn": "manhole_905_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392072.481987217208371, 5866534.25803626794368 ], [ 1392025.729596536839381, 5866516.925901044160128 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E144", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 929.79998779296875, "elevtn_dn": 892.29998779296875, "invlev_up": 927.29998779296875, "invlev_dn": 889.79998779296875, "manhole_up": "manhole_905_generated", "manhole_dn": "manhole_906_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392025.729596536839381, 5866516.925901044160128 ], [ 1391978.977205856470391, 5866499.593765820376575 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E145", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 892.29998779296875, "elevtn_dn": 911.4000244140625, "invlev_up": 889.79998779296875, "invlev_dn": 908.9000244140625, "manhole_up": "manhole_906_generated", "manhole_dn": "manhole_907_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391978.977205856470391, 5866499.593765820376575 ], [ 1391932.224815175868571, 5866482.261630596593022 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E146", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 911.4000244140625, "elevtn_dn": 911.4000244140625, "invlev_up": 908.9000244140625, "invlev_dn": 908.9000244140625, "manhole_up": "manhole_907_generated", "manhole_dn": "manhole_908_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391932.224815175868571, 5866482.261630596593022 ], [ 1391885.472424495499581, 5866464.92949537280947 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E147", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 911.4000244140625, "elevtn_dn": 933.20001220703125, "invlev_up": 908.9000244140625, "invlev_dn": 930.70001220703125, "manhole_up": "manhole_908_generated", "manhole_dn": "manhole_909_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391885.472424495499581, 5866464.92949537280947 ], [ 1391838.720033814897761, 5866447.59736014995724 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E148", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 933.20001220703125, "elevtn_dn": 933.20001220703125, "invlev_up": 930.70001220703125, "invlev_dn": 930.70001220703125, "manhole_up": "manhole_909_generated", "manhole_dn": "manhole_910_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391838.720033814897761, 5866447.59736014995724 ], [ 1391791.967643134528771, 5866430.265224926173687 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E149", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 933.20001220703125, "elevtn_dn": 939.4000244140625, "invlev_up": 930.70001220703125, "invlev_dn": 936.9000244140625, "manhole_up": "manhole_910_generated", "manhole_dn": "manhole_911_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391791.967643134528771, 5866430.265224926173687 ], [ 1391745.215252453926951, 5866412.933089702390134 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E150", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 939.4000244140625, "elevtn_dn": 939.4000244140625, "invlev_up": 936.9000244140625, "invlev_dn": 936.9000244140625, "manhole_up": "manhole_911_generated", "manhole_dn": "manhole_912_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391745.215252453926951, 5866412.933089702390134 ], [ 1391698.462861773557961, 5866395.600954478606582 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E151", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 939.4000244140625, "elevtn_dn": 952.70001220703125, "invlev_up": 936.9000244140625, "invlev_dn": 950.20001220703125, "manhole_up": "manhole_912_generated", "manhole_dn": "manhole_913_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391698.462861773557961, 5866395.600954478606582 ], [ 1391651.710471092956141, 5866378.268819254823029 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E152", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.70001220703125, "elevtn_dn": 889.4000244140625, "invlev_up": 950.20001220703125, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_913_generated", "manhole_dn": "manhole_914_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391651.710471092956141, 5866378.268819254823029 ], [ 1391604.958080412587151, 5866360.936684031039476 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E153", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 848.70001220703125, "invlev_up": 886.9000244140625, "invlev_dn": 846.20001220703125, "manhole_up": "manhole_914_generated", "manhole_dn": "manhole_915_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391604.958080412587151, 5866360.936684031039476 ], [ 1391558.205689732218161, 5866343.604548808187246 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E154", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 848.70001220703125, "elevtn_dn": 848.70001220703125, "invlev_up": 846.20001220703125, "invlev_dn": 846.20001220703125, "manhole_up": "manhole_915_generated", "manhole_dn": "manhole_916_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391558.205689732218161, 5866343.604548808187246 ], [ 1391511.453299051616341, 5866326.272413584403694 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E155", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 848.70001220703125, "elevtn_dn": 846.0, "invlev_up": 846.20001220703125, "invlev_dn": 843.5, "manhole_up": "manhole_916_generated", "manhole_dn": "manhole_917_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391511.453299051616341, 5866326.272413584403694 ], [ 1391464.700908371247351, 5866308.940278360620141 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E156", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 846.0, "elevtn_dn": 846.0, "invlev_up": 843.5, "invlev_dn": 843.5, "manhole_up": "manhole_917_generated", "manhole_dn": "manhole_918_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391464.700908371247351, 5866308.940278360620141 ], [ 1391417.948517690645531, 5866291.608143136836588 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E157", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 846.0, "elevtn_dn": 849.9000244140625, "invlev_up": 843.5, "invlev_dn": 847.4000244140625, "manhole_up": "manhole_918_generated", "manhole_dn": "manhole_919_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391417.948517690645531, 5866291.608143136836588 ], [ 1391371.196127010276541, 5866274.276007913053036 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E158", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 849.9000244140625, "elevtn_dn": 849.9000244140625, "invlev_up": 847.4000244140625, "invlev_dn": 847.4000244140625, "manhole_up": "manhole_919_generated", "manhole_dn": "manhole_920_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391371.196127010276541, 5866274.276007913053036 ], [ 1391321.986832652939484, 5866269.550851707346737 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E159", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 849.9000244140625, "elevtn_dn": 895.70001220703125, "invlev_up": 847.4000244140625, "invlev_dn": 893.20001220703125, "manhole_up": "manhole_920_generated", "manhole_dn": "manhole_921_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391321.986832652939484, 5866269.550851707346737 ], [ 1391272.147464629728347, 5866268.058758955448866 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E160", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 895.70001220703125, "elevtn_dn": 895.70001220703125, "invlev_up": 893.20001220703125, "invlev_dn": 893.20001220703125, "manhole_up": "manhole_921_generated", "manhole_dn": "manhole_922_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391272.147464629728347, 5866268.058758955448866 ], [ 1391222.30809660628438, 5866266.566666204482317 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E161", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 895.70001220703125, "elevtn_dn": 932.0, "invlev_up": 893.20001220703125, "invlev_dn": 929.5, "manhole_up": "manhole_922_generated", "manhole_dn": "manhole_923_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391222.30809660628438, 5866266.566666204482317 ], [ 1391172.468728582840413, 5866265.074573452584445 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E162", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 932.0, "invlev_up": 929.5, "invlev_dn": 929.5, "manhole_up": "manhole_923_generated", "manhole_dn": "manhole_924_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391172.468728582840413, 5866265.074573452584445 ], [ 1391122.629360559629276, 5866263.582480700686574 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E163", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 915.20001220703125, "invlev_up": 929.5, "invlev_dn": 912.70001220703125, "manhole_up": "manhole_924_generated", "manhole_dn": "manhole_925_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391122.629360559629276, 5866263.582480700686574 ], [ 1391072.789992536185309, 5866262.090387949720025 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E164", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.20001220703125, "elevtn_dn": 880.70001220703125, "invlev_up": 912.70001220703125, "invlev_dn": 878.20001220703125, "manhole_up": "manhole_925_generated", "manhole_dn": "manhole_926_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391072.789992536185309, 5866262.090387949720025 ], [ 1391022.950624512741342, 5866260.598295197822154 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E165", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 880.70001220703125, "elevtn_dn": 880.70001220703125, "invlev_up": 878.20001220703125, "invlev_dn": 878.20001220703125, "manhole_up": "manhole_926_generated", "manhole_dn": "manhole_927_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391022.950624512741342, 5866260.598295197822154 ], [ 1390973.111256489530206, 5866259.106202445924282 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E166", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 880.70001220703125, "elevtn_dn": 889.4000244140625, "invlev_up": 878.20001220703125, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_927_generated", "manhole_dn": "manhole_928_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390973.111256489530206, 5866259.106202445924282 ], [ 1390923.271888466086239, 5866257.614109694957733 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E167", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 889.4000244140625, "invlev_up": 886.9000244140625, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_928_generated", "manhole_dn": "manhole_929_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390923.271888466086239, 5866257.614109694957733 ], [ 1390873.432520442642272, 5866256.122016943059862 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E168", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 935.79998779296875, "invlev_up": 886.9000244140625, "invlev_dn": 933.29998779296875, "manhole_up": "manhole_929_generated", "manhole_dn": "manhole_930_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390873.432520442642272, 5866256.122016943059862 ], [ 1390823.593152419198304, 5866254.62992419116199 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E169", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.79998779296875, "elevtn_dn": 935.79998779296875, "invlev_up": 933.29998779296875, "invlev_dn": 933.29998779296875, "manhole_up": "manhole_930_generated", "manhole_dn": "manhole_931_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390823.593152419198304, 5866254.62992419116199 ], [ 1390773.753784395987168, 5866253.137831440195441 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E170", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.79998779296875, "elevtn_dn": 957.79998779296875, "invlev_up": 933.29998779296875, "invlev_dn": 955.29998779296875, "manhole_up": "manhole_931_generated", "manhole_dn": "manhole_932_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390773.753784395987168, 5866253.137831440195441 ], [ 1390723.914416372543201, 5866251.64573868829757 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E171", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.79998779296875, "elevtn_dn": 957.79998779296875, "invlev_up": 955.29998779296875, "invlev_dn": 955.29998779296875, "manhole_up": "manhole_932_generated", "manhole_dn": "manhole_933_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390723.914416372543201, 5866251.64573868829757 ], [ 1390674.075048349099234, 5866250.153645936399698 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E172", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.79998779296875, "elevtn_dn": 957.0, "invlev_up": 955.29998779296875, "invlev_dn": 954.5, "manhole_up": "manhole_933_generated", "manhole_dn": "manhole_934_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390674.075048349099234, 5866250.153645936399698 ], [ 1390624.235680325888097, 5866248.661553185433149 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E173", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.0, "elevtn_dn": 957.0, "invlev_up": 954.5, "invlev_dn": 954.5, "manhole_up": "manhole_934_generated", "manhole_dn": "manhole_935_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390624.235680325888097, 5866248.661553185433149 ], [ 1390574.39631230244413, 5866247.169460433535278 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E174", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.0, "elevtn_dn": 964.5, "invlev_up": 954.5, "invlev_dn": 962.0, "manhole_up": "manhole_935_generated", "manhole_dn": "manhole_936_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390574.39631230244413, 5866247.169460433535278 ], [ 1390524.556944279000163, 5866245.677367681637406 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E175", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 964.5, "invlev_up": 962.0, "invlev_dn": 962.0, "manhole_up": "manhole_936_generated", "manhole_dn": "manhole_937_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390524.556944279000163, 5866245.677367681637406 ], [ 1390474.717576255789027, 5866244.185274930670857 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E176", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 948.5, "invlev_up": 962.0, "invlev_dn": 946.0, "manhole_up": "manhole_937_generated", "manhole_dn": "manhole_938_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390474.717576255789027, 5866244.185274930670857 ], [ 1390424.87820823234506, 5866242.693182178772986 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E177", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 948.5, "elevtn_dn": 970.10003662109375, "invlev_up": 946.0, "invlev_dn": 967.60003662109375, "manhole_up": "manhole_938_generated", "manhole_dn": "manhole_939_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390424.87820823234506, 5866242.693182178772986 ], [ 1390375.038840208901092, 5866241.201089426875114 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E178", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 970.10003662109375, "elevtn_dn": 970.10003662109375, "invlev_up": 967.60003662109375, "invlev_dn": 967.60003662109375, "manhole_up": "manhole_939_generated", "manhole_dn": "manhole_940_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390375.038840208901092, 5866241.201089426875114 ], [ 1390325.199472185689956, 5866239.708996675908566 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E179", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 970.10003662109375, "elevtn_dn": 975.4000244140625, "invlev_up": 967.60003662109375, "invlev_dn": 972.9000244140625, "manhole_up": "manhole_940_generated", "manhole_dn": "manhole_941_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390325.199472185689956, 5866239.708996675908566 ], [ 1390275.360104162245989, 5866238.216903924010694 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E180", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 975.4000244140625, "elevtn_dn": 975.4000244140625, "invlev_up": 972.9000244140625, "invlev_dn": 972.9000244140625, "manhole_up": "manhole_941_generated", "manhole_dn": "manhole_942_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390275.360104162245989, 5866238.216903924010694 ], [ 1390225.520736138802022, 5866236.724811173044145 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E181", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 975.4000244140625, "elevtn_dn": 1034.5, "invlev_up": 972.9000244140625, "invlev_dn": 1032.0, "manhole_up": "manhole_942_generated", "manhole_dn": "manhole_943_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390225.520736138802022, 5866236.724811173044145 ], [ 1390175.681368115358055, 5866235.232718421146274 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E182", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1034.5, "elevtn_dn": 1034.5, "invlev_up": 1032.0, "invlev_dn": 1032.0, "manhole_up": "manhole_943_generated", "manhole_dn": "manhole_944_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390175.681368115358055, 5866235.232718421146274 ], [ 1390125.842000092146918, 5866233.740625669248402 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E183", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1034.5, "elevtn_dn": 1053.9000244140625, "invlev_up": 1032.0, "invlev_dn": 1051.4000244140625, "manhole_up": "manhole_944_generated", "manhole_dn": "manhole_945_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390125.842000092146918, 5866233.740625669248402 ], [ 1390076.002632068702951, 5866232.248532918281853 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E184", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1053.9000244140625, "elevtn_dn": 956.9000244140625, "invlev_up": 1051.4000244140625, "invlev_dn": 954.4000244140625, "manhole_up": "manhole_945_generated", "manhole_dn": "manhole_946_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390076.002632068702951, 5866232.248532918281853 ], [ 1390026.163264045258984, 5866230.756440166383982 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E185", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 956.9000244140625, "elevtn_dn": 988.79998779296875, "invlev_up": 954.4000244140625, "invlev_dn": 986.29998779296875, "manhole_up": "manhole_946_generated", "manhole_dn": "manhole_947_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390026.163264045258984, 5866230.756440166383982 ], [ 1389976.323896022047848, 5866229.26434741448611 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E186", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 988.79998779296875, "elevtn_dn": 988.79998779296875, "invlev_up": 986.29998779296875, "invlev_dn": 986.29998779296875, "manhole_up": "manhole_947_generated", "manhole_dn": "manhole_948_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389976.323896022047848, 5866229.26434741448611 ], [ 1389926.48452799860388, 5866227.772254663519561 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E187", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 988.79998779296875, "elevtn_dn": 1051.0999755859375, "invlev_up": 986.29998779296875, "invlev_dn": 1048.5999755859375, "manhole_up": "manhole_948_generated", "manhole_dn": "manhole_949_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389926.48452799860388, 5866227.772254663519561 ], [ 1389876.645159975159913, 5866226.28016191162169 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E188", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1051.0999755859375, "elevtn_dn": 1051.0999755859375, "invlev_up": 1048.5999755859375, "invlev_dn": 1048.5999755859375, "manhole_up": "manhole_949_generated", "manhole_dn": "manhole_950_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389876.645159975159913, 5866226.28016191162169 ], [ 1389826.805791951948777, 5866224.788069159723818 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E189", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1051.0999755859375, "elevtn_dn": 1066.9000244140625, "invlev_up": 1048.5999755859375, "invlev_dn": 1064.4000244140625, "manhole_up": "manhole_950_generated", "manhole_dn": "manhole_951_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389826.805791951948777, 5866224.788069159723818 ], [ 1389776.96642392850481, 5866223.295976408757269 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E190", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1066.9000244140625, "elevtn_dn": 1031.2000732421875, "invlev_up": 1064.4000244140625, "invlev_dn": 1028.7000732421875, "manhole_up": "manhole_951_generated", "manhole_dn": "manhole_952_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389776.96642392850481, 5866223.295976408757269 ], [ 1389727.141182830790058, 5866221.468200048431754 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E191", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1031.2000732421875, "elevtn_dn": 1031.2000732421875, "invlev_up": 1028.7000732421875, "invlev_dn": 1028.7000732421875, "manhole_up": "manhole_952_generated", "manhole_dn": "manhole_953_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389727.141182830790058, 5866221.468200048431754 ], [ 1389677.352675863076001, 5866218.767548334784806 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E192", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1031.2000732421875, "elevtn_dn": 986.60003662109375, "invlev_up": 1028.7000732421875, "invlev_dn": 984.10003662109375, "manhole_up": "manhole_953_generated", "manhole_dn": "manhole_954_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389677.352675863076001, 5866218.767548334784806 ], [ 1389627.564168895594776, 5866216.066896621137857 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E193", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 986.60003662109375, "elevtn_dn": 986.60003662109375, "invlev_up": 984.10003662109375, "invlev_dn": 984.10003662109375, "manhole_up": "manhole_954_generated", "manhole_dn": "manhole_955_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389627.564168895594776, 5866216.066896621137857 ], [ 1389577.775661927880719, 5866213.366244907490909 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E194", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 986.60003662109375, "elevtn_dn": 964.70001220703125, "invlev_up": 984.10003662109375, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_955_generated", "manhole_dn": "manhole_956_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389577.775661927880719, 5866213.366244907490909 ], [ 1389527.987154960166663, 5866210.665593194775283 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E195", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 964.70001220703125, "invlev_up": 962.20001220703125, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_956_generated", "manhole_dn": "manhole_957_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389527.987154960166663, 5866210.665593194775283 ], [ 1389478.198647992452607, 5866207.964941481128335 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E196", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 996.29998779296875, "invlev_up": 962.20001220703125, "invlev_dn": 993.79998779296875, "manhole_up": "manhole_957_generated", "manhole_dn": "manhole_958_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389478.198647992452607, 5866207.964941481128335 ], [ 1389428.41014102473855, 5866205.264289767481387 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E197", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 996.29998779296875, "elevtn_dn": 996.29998779296875, "invlev_up": 993.79998779296875, "invlev_dn": 993.79998779296875, "manhole_up": "manhole_958_generated", "manhole_dn": "manhole_959_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389428.41014102473855, 5866205.264289767481387 ], [ 1389378.621634057024494, 5866202.563638053834438 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E198", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 996.29998779296875, "elevtn_dn": 1030.4000244140625, "invlev_up": 993.79998779296875, "invlev_dn": 1027.9000244140625, "manhole_up": "manhole_959_generated", "manhole_dn": "manhole_960_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389378.621634057024494, 5866202.563638053834438 ], [ 1389328.833127089310437, 5866199.86298634018749 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E199", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1030.4000244140625, "elevtn_dn": 1030.4000244140625, "invlev_up": 1027.9000244140625, "invlev_dn": 1027.9000244140625, "manhole_up": "manhole_960_generated", "manhole_dn": "manhole_961_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389328.833127089310437, 5866199.86298634018749 ], [ 1389279.044620121829212, 5866197.162334626540542 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E200", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1030.4000244140625, "elevtn_dn": 1053.800048828125, "invlev_up": 1027.9000244140625, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_961_generated", "manhole_dn": "manhole_962_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389279.044620121829212, 5866197.162334626540542 ], [ 1389229.256113154115155, 5866194.461682912893593 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E201", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1053.800048828125, "invlev_up": 1051.300048828125, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_962_generated", "manhole_dn": "manhole_963_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389229.256113154115155, 5866194.461682912893593 ], [ 1389179.467606186401099, 5866191.761031199246645 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E202", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1067.5999755859375, "invlev_up": 1051.300048828125, "invlev_dn": 1065.0999755859375, "manhole_up": "manhole_963_generated", "manhole_dn": "manhole_964_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389179.467606186401099, 5866191.761031199246645 ], [ 1389129.679099218687043, 5866189.060379485599697 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E203", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1067.5999755859375, "elevtn_dn": 1070.7000732421875, "invlev_up": 1065.0999755859375, "invlev_dn": 1068.2000732421875, "manhole_up": "manhole_964_generated", "manhole_dn": "manhole_965_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389129.679099218687043, 5866189.060379485599697 ], [ 1389079.890592250972986, 5866186.359727771952748 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E204", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1070.7000732421875, "elevtn_dn": 1070.7000732421875, "invlev_up": 1068.2000732421875, "invlev_dn": 1068.2000732421875, "manhole_up": "manhole_965_generated", "manhole_dn": "manhole_966_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389079.890592250972986, 5866186.359727771952748 ], [ 1389030.10208528325893, 5866183.6590760583058 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E205", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1070.7000732421875, "elevtn_dn": 1075.0, "invlev_up": 1068.2000732421875, "invlev_dn": 1072.5, "manhole_up": "manhole_966_generated", "manhole_dn": "manhole_967_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389030.10208528325893, 5866183.6590760583058 ], [ 1388980.313578315777704, 5866180.958424345590174 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E206", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1075.0, "elevtn_dn": 1075.0, "invlev_up": 1072.5, "invlev_dn": 1072.5, "manhole_up": "manhole_967_generated", "manhole_dn": "manhole_968_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388980.313578315777704, 5866180.958424345590174 ], [ 1388930.525071348063648, 5866178.257772631943226 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E207", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1075.0, "elevtn_dn": 1074.0999755859375, "invlev_up": 1072.5, "invlev_dn": 1071.5999755859375, "manhole_up": "manhole_968_generated", "manhole_dn": "manhole_969_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388930.525071348063648, 5866178.257772631943226 ], [ 1388880.736564380349591, 5866175.557120918296278 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E208", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1074.0999755859375, "elevtn_dn": 1074.0999755859375, "invlev_up": 1071.5999755859375, "invlev_dn": 1071.5999755859375, "manhole_up": "manhole_969_generated", "manhole_dn": "manhole_970_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388880.736564380349591, 5866175.557120918296278 ], [ 1388830.948057412635535, 5866172.856469204649329 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E209", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1074.0999755859375, "elevtn_dn": 1053.800048828125, "invlev_up": 1071.5999755859375, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_970_generated", "manhole_dn": "manhole_971_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388830.948057412635535, 5866172.856469204649329 ], [ 1388781.159550444921479, 5866170.155817491002381 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E210", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1053.800048828125, "invlev_up": 1051.300048828125, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_971_generated", "manhole_dn": "manhole_972_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388781.159550444921479, 5866170.155817491002381 ], [ 1388731.371043477207422, 5866167.455165777355433 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E211", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1017.0, "invlev_up": 1051.300048828125, "invlev_dn": 1014.5, "manhole_up": "manhole_972_generated", "manhole_dn": "manhole_973_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388731.371043477207422, 5866167.455165777355433 ], [ 1388681.582536509493366, 5866164.754514063708484 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E212", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1017.0, "elevtn_dn": 1017.0, "invlev_up": 1014.5, "invlev_dn": 1014.5, "manhole_up": "manhole_973_generated", "manhole_dn": "manhole_974_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388681.582536509493366, 5866164.754514063708484 ], [ 1388631.79402954201214, 5866162.053862350061536 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E213", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1017.0, "elevtn_dn": 973.20001220703125, "invlev_up": 1014.5, "invlev_dn": 970.70001220703125, "manhole_up": "manhole_974_generated", "manhole_dn": "manhole_975_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388631.79402954201214, 5866162.053862350061536 ], [ 1388582.005522574298084, 5866159.353210636414587 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E214", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 973.20001220703125, "elevtn_dn": 973.20001220703125, "invlev_up": 970.70001220703125, "invlev_dn": 970.70001220703125, "manhole_up": "manhole_975_generated", "manhole_dn": "manhole_976_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388582.005522574298084, 5866159.353210636414587 ], [ 1388532.217015606584027, 5866156.652558922767639 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E215", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 973.20001220703125, "elevtn_dn": 935.20001220703125, "invlev_up": 970.70001220703125, "invlev_dn": 932.70001220703125, "manhole_up": "manhole_976_generated", "manhole_dn": "manhole_977_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388532.217015606584027, 5866156.652558922767639 ], [ 1388482.428508638869971, 5866153.951907209120691 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E216", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.20001220703125, "elevtn_dn": 935.20001220703125, "invlev_up": 932.70001220703125, "invlev_dn": 932.70001220703125, "manhole_up": "manhole_977_generated", "manhole_dn": "manhole_978_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388482.428508638869971, 5866153.951907209120691 ], [ 1388432.640001671155915, 5866151.251255496405065 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E217", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.20001220703125, "elevtn_dn": 895.79998779296875, "invlev_up": 932.70001220703125, "invlev_dn": 893.29998779296875, "manhole_up": "manhole_978_generated", "manhole_dn": "manhole_979_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388432.640001671155915, 5866151.251255496405065 ], [ 1388382.851494703441858, 5866148.550603782758117 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E218", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 895.79998779296875, "elevtn_dn": 852.60003662109375, "invlev_up": 893.29998779296875, "invlev_dn": 850.10003662109375, "manhole_up": "manhole_979_generated", "manhole_dn": "manhole_980_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388382.851494703441858, 5866148.550603782758117 ], [ 1388333.062987735960633, 5866145.849952069111168 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E219", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 852.60003662109375, "elevtn_dn": 852.60003662109375, "invlev_up": 850.10003662109375, "invlev_dn": 850.10003662109375, "manhole_up": "manhole_980_generated", "manhole_dn": "manhole_981_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388333.062987735960633, 5866145.849952069111168 ], [ 1388283.274480768246576, 5866143.14930035546422 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E220", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 852.60003662109375, "elevtn_dn": 818.4000244140625, "invlev_up": 850.10003662109375, "invlev_dn": 815.9000244140625, "manhole_up": "manhole_981_generated", "manhole_dn": "manhole_982_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388283.274480768246576, 5866143.14930035546422 ], [ 1388233.48597380053252, 5866140.448648641817272 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E221", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 818.4000244140625, "elevtn_dn": 818.4000244140625, "invlev_up": 815.9000244140625, "invlev_dn": 815.9000244140625, "manhole_up": "manhole_982_generated", "manhole_dn": "manhole_983_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388233.48597380053252, 5866140.448648641817272 ], [ 1388183.697466832818463, 5866137.747996928170323 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_50_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 792.20001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_851_generated", "manhole_dn": "manhole_984_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387913.197226775344461, 5865736.839239663444459 ], [ 1387925.20445894007571, 5865784.545682998374104 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_50_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 804.4000244140625, "invlev_up": 792.20001220703125, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_984_generated", "manhole_dn": "manhole_985_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387925.20445894007571, 5865784.545682998374104 ], [ 1387937.21169110503979, 5865832.252126332372427 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_50_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_985_generated", "manhole_dn": "manhole_986_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387937.21169110503979, 5865832.252126332372427 ], [ 1387954.8270876808092, 5865878.043407939374447 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_50_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_986_generated", "manhole_dn": "manhole_987_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387954.8270876808092, 5865878.043407939374447 ], [ 1387967.620662312954664, 5865925.436966767534614 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_50_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 778.20001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_987_generated", "manhole_dn": "manhole_988_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387967.620662312954664, 5865925.436966767534614 ], [ 1387969.561903131194413, 5865974.386314341798425 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_50_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_988_generated", "manhole_dn": "manhole_989_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.561903131194413, 5865974.386314341798425 ], [ 1387968.98255812516436, 5866023.571071763522923 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_50_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_989_generated", "manhole_dn": "manhole_990_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387968.98255812516436, 5866023.571071763522923 ], [ 1387969.225197304505855, 5866072.657253311946988 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_50_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 786.29998779296875, "invlev_up": 775.70001220703125, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_990_generated", "manhole_dn": "manhole_991_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.225197304505855, 5866072.657253311946988 ], [ 1387988.247399942483753, 5866112.298415473662317 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_50_E8", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 786.29998779296875, "invlev_up": 783.79998779296875, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_991_generated", "manhole_dn": "manhole_992_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387988.247399942483753, 5866112.298415473662317 ], [ 1388034.037428337847814, 5866130.255607943050563 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_51_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 786.29998779296875, "invlev_up": 783.79998779296875, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_992_generated", "manhole_dn": "manhole_993_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388034.037428337847814, 5866130.255607943050563 ], [ 1387988.210684564430267, 5866144.678138472139835 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_51_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 803.9000244140625, "invlev_up": 783.79998779296875, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_993_generated", "manhole_dn": "manhole_994_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387988.210684564430267, 5866144.678138472139835 ], [ 1387944.406121137319133, 5866164.065103021450341 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_51_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_994_generated", "manhole_dn": "manhole_995_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387944.406121137319133, 5866164.065103021450341 ], [ 1387898.376188111724332, 5866173.560075835324824 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_51_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 827.70001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_995_generated", "manhole_dn": "manhole_996_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387898.376188111724332, 5866173.560075835324824 ], [ 1387861.922560503939167, 5866145.113870099186897 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_51_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_996_generated", "manhole_dn": "manhole_997_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387861.922560503939167, 5866145.113870099186897 ], [ 1387862.597008766839281, 5866099.287653629668057 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_51_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_997_generated", "manhole_dn": "manhole_998_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387862.597008766839281, 5866099.287653629668057 ], [ 1387894.296242429409176, 5866064.31225199252367 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_51_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_998_generated", "manhole_dn": "manhole_999_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387894.296242429409176, 5866064.31225199252367 ], [ 1387918.333023339277133, 5866023.860149594023824 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_51_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_999_generated", "manhole_dn": "manhole_1000_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387918.333023339277133, 5866023.860149594023824 ], [ 1387925.576027213362977, 5865976.462517648003995 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_51_E8", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 804.4000244140625, "invlev_up": 814.20001220703125, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1000_generated", "manhole_dn": "manhole_1001_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387925.576027213362977, 5865976.462517648003995 ], [ 1387926.166851800866425, 5865928.505292822606862 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_51_E9", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1001_generated", "manhole_dn": "manhole_1002_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387926.166851800866425, 5865928.505292822606862 ], [ 1387922.175474973395467, 5865880.628693707287312 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_51_E10", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1002_generated", "manhole_dn": "manhole_1003_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387922.175474973395467, 5865880.628693707287312 ], [ 1387918.184098146157339, 5865832.752094592899084 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_51_E11", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 794.70001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_1003_generated", "manhole_dn": "manhole_1004_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387918.184098146157339, 5865832.752094592899084 ], [ 1387914.316889721900225, 5865784.868878290057182 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_51_E12", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 792.20001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_1004_generated", "manhole_dn": "manhole_851_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387914.316889721900225, 5865784.868878290057182 ], [ 1387913.197226775344461, 5865736.839239663444459 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_52_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_52", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 818.4000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 815.9000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_983_generated", "manhole_dn": "manhole_1005_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388183.697466832818463, 5866137.747996928170323 ], [ 1388133.810787334572524, 5866135.250533932819963 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_52_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_52", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_1005_generated", "manhole_dn": "manhole_1006_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388133.810787334572524, 5866135.250533932819963 ], [ 1388083.924107836093754, 5866132.753070938400924 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_52_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_52", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 786.29998779296875, "invlev_up": 801.4000244140625, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_1006_generated", "manhole_dn": "manhole_992_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388083.924107836093754, 5866132.753070938400924 ], [ 1388034.037428337847814, 5866130.255607943050563 ] ] } }, -{ "type": "Feature", "properties": { "width": 60.500781333333329, "branchtype": "river", "bedlev": 849.79998779296875, "height": 24.5, "branchid": "river_1", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_1", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1393117.044156666612253, 5866704.071640181355178 ], [ 1393024.277914338745177, 5866704.071640181355178 ], [ 1392931.511672010878101, 5866704.071640181355178 ], [ 1392838.745429683011025, 5866704.071640181355178 ], [ 1392745.979187355143949, 5866569.217538605444133 ], [ 1392653.212945027276874, 5866569.217538605444133 ], [ 1392560.446702699409798, 5866569.217538605444133 ], [ 1392467.680460371775553, 5866569.217538605444133 ], [ 1392374.914218043908477, 5866569.217538605444133 ], [ 1392282.147975716041401, 5866434.365506432019174 ], [ 1392189.381733388174325, 5866299.515543566085398 ], [ 1392096.615491060307249, 5866299.515543566085398 ], [ 1392003.849248732440174, 5866299.515543566085398 ], [ 1391911.083006404573098, 5866299.515543566085398 ], [ 1391818.316764076706022, 5866164.667649917304516 ], [ 1391725.550521749071777, 5866164.667649917304516 ], [ 1391632.784279421204701, 5866164.667649917304516 ], [ 1391540.018037093337625, 5866164.667649917304516 ], [ 1391447.251794765470549, 5866164.667649917304516 ], [ 1391354.485552437603474, 5866164.667649917304516 ], [ 1391261.719310109736398, 5866164.667649917304516 ], [ 1391168.953067781869322, 5866164.667649917304516 ], [ 1391076.186825454002246, 5866164.667649917304516 ], [ 1390983.42058312613517, 5866164.667649917304516 ], [ 1390890.654340798500925, 5866164.667649917304516 ], [ 1390797.88809847063385, 5866029.821825393475592 ], [ 1390705.121856142766774, 5866029.821825393475592 ], [ 1390612.355613814899698, 5866029.821825393475592 ], [ 1390519.589371487032622, 5866029.821825393475592 ], [ 1390426.823129159165546, 5866029.821825393475592 ], [ 1390334.05688683129847, 5866029.821825393475592 ], [ 1390241.290644503431395, 5866029.821825393475592 ], [ 1390148.524402175564319, 5865894.978069900535047 ], [ 1390055.758159847930074, 5865894.978069900535047 ], [ 1389962.991917520062998, 5865760.136383350938559 ], [ 1389870.225675192195922, 5865760.136383350938559 ], [ 1389777.459432864328846, 5865760.136383350938559 ], [ 1389684.693190536461771, 5865760.136383350938559 ], [ 1389591.926948208594695, 5865760.136383350938559 ], [ 1389499.160705880727619, 5865625.296765648759902 ], [ 1389406.394463552860543, 5865625.296765648759902 ], [ 1389406.394463552860543, 5865490.459216703660786 ], [ 1389313.628221225226298, 5865355.623736422508955 ], [ 1389313.628221225226298, 5865220.790324714966118 ], [ 1389313.628221225226298, 5865085.958981487900019 ], [ 1389220.861978897359222, 5864951.129706649109721 ], [ 1389128.095736569492146, 5864816.302500107325613 ], [ 1389128.095736569492146, 5864681.477361768484116 ], [ 1389035.329494241625071, 5864546.654291545040905 ], [ 1389128.095736569492146, 5864411.833289341069758 ], [ 1389128.095736569492146, 5864277.014355066232383 ], [ 1389035.329494241625071, 5864142.197488628327847 ], [ 1388942.563251913757995, 5864007.382689935155213 ], [ 1388849.797009585890919, 5863872.56995889544487 ], [ 1388757.030767258023843, 5863872.56995889544487 ], [ 1388664.264524930156767, 5863737.759295415133238 ], [ 1388571.498282602289692, 5863602.950699404813349 ], [ 1388571.498282602289692, 5863468.144170772284269 ], [ 1388571.498282602289692, 5863333.339709425345063 ], [ 1388478.732040274655446, 5863333.339709425345063 ], [ 1388385.965797946788371, 5863198.537315271794796 ], [ 1388293.199555618921295, 5863198.537315271794796 ], [ 1388200.433313291054219, 5863198.537315271794796 ], [ 1388107.667070963187143, 5863063.73698821850121 ], [ 1388014.900828635320067, 5863063.73698821850121 ], [ 1387922.134586307452992, 5863063.73698821850121 ], [ 1387829.368343979585916, 5862928.938728175126016 ], [ 1387736.60210165171884, 5862794.142535049468279 ], [ 1387736.60210165171884, 5862659.348408750258386 ], [ 1387736.60210165171884, 5862524.55634918436408 ], [ 1387643.835859324084595, 5862389.766356258653104 ], [ 1387551.069616996217519, 5862254.978429885581136 ], [ 1387458.303374668350443, 5862254.978429885581136 ], [ 1387365.537132340483367, 5862254.978429885581136 ], [ 1387272.770890012616292, 5862254.978429885581136 ], [ 1387180.004647684749216, 5862254.978429885581136 ], [ 1387087.23840535688214, 5862254.978429885581136 ], [ 1386994.472163029015064, 5862120.19256996922195 ] ] } }, -{ "type": "Feature", "properties": { "width": 63.595319, "branchtype": "river", "bedlev": 789.5, "height": 15.025009155273438, "branchid": "river_2", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_2", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1387829.368343979585916, 5866704.071640181355178 ], [ 1387829.368343979585916, 5866569.217538605444133 ], [ 1387922.134586307452992, 5866434.365506432019174 ], [ 1387922.134586307452992, 5866299.515543566085398 ], [ 1388014.900828635320067, 5866164.667649917304516 ], [ 1388014.900828635320067, 5866029.821825393475592 ], [ 1388014.900828635320067, 5865894.978069900535047 ], [ 1388014.900828635320067, 5865760.136383350938559 ], [ 1387922.134586307452992, 5865625.296765648759902 ], [ 1387922.134586307452992, 5865490.459216703660786 ], [ 1387922.134586307452992, 5865355.623736422508955 ], [ 1387922.134586307452992, 5865220.790324714966118 ], [ 1387922.134586307452992, 5865085.958981487900019 ], [ 1387829.368343979585916, 5864951.129706649109721 ], [ 1387829.368343979585916, 5864816.302500107325613 ], [ 1387829.368343979585916, 5864681.477361768484116 ], [ 1387829.368343979585916, 5864546.654291545040905 ], [ 1387829.368343979585916, 5864411.833289341069758 ], [ 1387829.368343979585916, 5864277.014355066232383 ], [ 1387736.60210165171884, 5864142.197488628327847 ], [ 1387643.835859324084595, 5864007.382689935155213 ], [ 1387551.069616996217519, 5863872.56995889544487 ], [ 1387551.069616996217519, 5863737.759295415133238 ], [ 1387458.303374668350443, 5863602.950699404813349 ], [ 1387365.537132340483367, 5863468.144170772284269 ], [ 1387272.770890012616292, 5863333.339709425345063 ], [ 1387272.770890012616292, 5863198.537315271794796 ], [ 1387180.004647684749216, 5863063.73698821850121 ], [ 1387087.23840535688214, 5862928.938728175126016 ], [ 1386994.472163029015064, 5862794.142535049468279 ], [ 1386901.705920701380819, 5862794.142535049468279 ], [ 1386808.939678373513743, 5862659.348408750258386 ], [ 1386716.173436045646667, 5862524.55634918436408 ], [ 1386716.173436045646667, 5862389.766356258653104 ], [ 1386716.173436045646667, 5862254.978429885581136 ], [ 1386808.939678373513743, 5862254.978429885581136 ], [ 1386901.705920701380819, 5862120.19256996922195 ], [ 1386994.472163029015064, 5862120.19256996922195 ] ] } }, -{ "type": "Feature", "properties": { "width": 50.0, "branchtype": "river", "bedlev": 952.79998779296875, "height": 21.70001220703125, "branchid": "river_3", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_3", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1391540.018037093337625, 5858077.577220032922924 ], [ 1391447.251794765470549, 5858077.577220032922924 ], [ 1391354.485552437603474, 5858077.577220032922924 ], [ 1391261.719310109736398, 5858077.577220032922924 ], [ 1391168.953067781869322, 5858077.577220032922924 ], [ 1391076.186825454002246, 5858212.301128901541233 ], [ 1390983.42058312613517, 5858212.301128901541233 ], [ 1390890.654340798500925, 5858212.301128901541233 ], [ 1390797.88809847063385, 5858077.577220032922924 ], [ 1390705.121856142766774, 5858077.577220032922924 ], [ 1390612.355613814899698, 5858077.577220032922924 ], [ 1390519.589371487032622, 5858077.577220032922924 ], [ 1390426.823129159165546, 5858077.577220032922924 ], [ 1390334.05688683129847, 5857942.855374775826931 ], [ 1390241.290644503431395, 5857942.855374775826931 ], [ 1390148.524402175564319, 5857942.855374775826931 ], [ 1390055.758159847930074, 5857808.135593039914966 ], [ 1389962.991917520062998, 5857808.135593039914966 ], [ 1389962.991917520062998, 5857673.417874733917415 ], [ 1389870.225675192195922, 5857673.417874733917415 ], [ 1389777.459432864328846, 5857673.417874733917415 ], [ 1389684.693190536461771, 5857808.135593039914966 ], [ 1389591.926948208594695, 5857808.135593039914966 ], [ 1389499.160705880727619, 5857808.135593039914966 ], [ 1389406.394463552860543, 5857808.135593039914966 ], [ 1389313.628221225226298, 5857942.855374775826931 ], [ 1389220.861978897359222, 5858077.577220032922924 ], [ 1389128.095736569492146, 5858212.301128901541233 ], [ 1389035.329494241625071, 5858212.301128901541233 ], [ 1388942.563251913757995, 5858347.02710147574544 ], [ 1388849.797009585890919, 5858347.02710147574544 ], [ 1388757.030767258023843, 5858347.02710147574544 ], [ 1388664.264524930156767, 5858481.75513784494251 ], [ 1388571.498282602289692, 5858481.75513784494251 ], [ 1388478.732040274655446, 5858481.75513784494251 ], [ 1388385.965797946788371, 5858481.75513784494251 ], [ 1388293.199555618921295, 5858481.75513784494251 ], [ 1388200.433313291054219, 5858616.485238100402057 ], [ 1388107.667070963187143, 5858751.217402335256338 ], [ 1388014.900828635320067, 5858885.951630644500256 ], [ 1387922.134586307452992, 5858885.951630644500256 ], [ 1387829.368343979585916, 5858885.951630644500256 ], [ 1387736.60210165171884, 5858885.951630644500256 ], [ 1387643.835859324084595, 5858885.951630644500256 ], [ 1387551.069616996217519, 5858885.951630644500256 ], [ 1387458.303374668350443, 5858885.951630644500256 ], [ 1387365.537132340483367, 5858885.951630644500256 ], [ 1387272.770890012616292, 5858885.951630644500256 ], [ 1387180.004647684749216, 5858885.951630644500256 ], [ 1387087.23840535688214, 5858885.951630644500256 ], [ 1386994.472163029015064, 5858885.951630644500256 ], [ 1386901.705920701380819, 5858885.951630644500256 ], [ 1386808.939678373513743, 5858885.951630644500256 ], [ 1386716.173436045646667, 5859020.687923113815486 ], [ 1386623.407193717779592, 5859020.687923113815486 ], [ 1386530.640951389912516, 5859020.687923113815486 ], [ 1386437.87470906204544, 5859020.687923113815486 ], [ 1386345.108466734178364, 5859020.687923113815486 ] ] } }, -{ "type": "Feature", "properties": { "width": 60.93007025, "branchtype": "river", "bedlev": 724.29998779296875, "height": 14.050003051757812, "branchid": "river_4", "branchorder": "1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_4", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386994.472163029015064, 5862120.19256996922195 ], [ 1386901.705920701380819, 5861985.408776419237256 ], [ 1386808.939678373513743, 5861850.62704914342612 ], [ 1386716.173436045646667, 5861715.847388052381575 ], [ 1386716.173436045646667, 5861581.069793050177395 ], [ 1386716.173436045646667, 5861446.294264047406614 ], [ 1386648.271799877518788, 5861347.644815167412162 ] ] } }, -{ "type": "Feature", "properties": { "width": 60.93007025, "branchtype": "river", "bedlev": 724.29998779296875, "height": 14.050003051757812, "branchid": "river_4-1", "branchorder": "1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_4", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386648.271799877518788, 5861347.644815167412162 ], [ 1386623.407193717779592, 5861311.520800950936973 ], [ 1386623.407193717779592, 5861176.749403670430183 ], [ 1386530.640951389912516, 5861176.749403670430183 ], [ 1386437.87470906204544, 5861041.98007211368531 ], [ 1386437.87470906204544, 5860907.21280618570745 ], [ 1386437.87470906204544, 5860772.447605800814927 ], [ 1386437.87470906204544, 5860637.684470860287547 ], [ 1386345.108466734178364, 5860502.923401278443635 ], [ 1386345.108466734178364, 5860368.164396960288286 ], [ 1386252.342224406311288, 5860233.40745781455189 ], [ 1386159.575982078444213, 5860098.652583749964833 ], [ 1386159.575982078444213, 5859963.899774672463536 ], [ 1386159.575982078444213, 5859829.149030492641032 ], [ 1386159.575982078444213, 5859694.400351119227707 ], [ 1386252.342224406311288, 5859559.653736458159983 ], [ 1386252.342224406311288, 5859424.909186419099569 ], [ 1386252.342224406311288, 5859290.166700908914208 ], [ 1386252.342224406311288, 5859155.426279838196933 ], [ 1386345.108466734178364, 5859020.687923113815486 ] ] } }, -{ "type": "Feature", "properties": { "width": 60.93007025, "branchtype": "river", "bedlev": 701.4000244140625, "height": 15.174972534179688, "branchid": "river_5", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_5", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386345.108466734178364, 5859020.687923113815486 ], [ 1386252.342224406311288, 5858885.951630644500256 ], [ 1386159.575982078444213, 5858751.217402335256338 ], [ 1386159.575982078444213, 5858616.485238100402057 ], [ 1386159.575982078444213, 5858481.75513784494251 ], [ 1386159.575982078444213, 5858347.02710147574544 ], [ 1386066.809739750809968, 5858212.301128901541233 ], [ 1385974.043497422942892, 5858212.301128901541233 ], [ 1385881.277255095075816, 5858212.301128901541233 ], [ 1385788.51101276720874, 5858212.301128901541233 ], [ 1385695.744770439341664, 5858212.301128901541233 ], [ 1385602.978528111474589, 5858077.577220032922924 ], [ 1385510.212285783607513, 5857942.855374775826931 ], [ 1385510.212285783607513, 5857808.135593039914966 ], [ 1385417.446043455740437, 5857673.417874733917415 ], [ 1385324.679801127873361, 5857673.417874733917415 ], [ 1385231.913558800239116, 5857538.7022197637707 ], [ 1385231.913558800239116, 5857403.988628040067852 ], [ 1385231.913558800239116, 5857269.277099470607936 ], [ 1385231.913558800239116, 5857134.567633963190019 ], [ 1385324.679801127873361, 5856999.860231426544487 ], [ 1385231.913558800239116, 5856865.154891768470407 ], [ 1385231.913558800239116, 5856730.451614897698164 ], [ 1385139.14731647237204, 5856595.750400722026825 ], [ 1385046.381074144504964, 5856595.750400722026825 ], [ 1384953.614831816637889, 5856461.0512491511181 ], [ 1384860.848589488770813, 5856461.0512491511181 ], [ 1384768.082347160903737, 5856326.354160091839731 ], [ 1384768.082347160903737, 5856191.659133451990783 ], [ 1384675.316104833036661, 5856056.966169143095613 ], [ 1384582.549862505169585, 5856056.966169143095613 ], [ 1384489.78362017753534, 5855922.275267072021961 ], [ 1384397.017377849668264, 5855787.586427142843604 ], [ 1384304.251135521801189, 5855787.586427142843604 ], [ 1384211.484893193934113, 5855652.899649270810187 ], [ 1384118.718650866067037, 5855518.214933359995484 ] ] } } ->>>>>>> main +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_6_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_1_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389238.298387300921604, 5860147.714495398104191 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_6_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 933.5, "invlev_up": 913.4000244140625, "invlev_dn": 931.0, "manhole_up": "manhole_1_generated", "manhole_dn": "manhole_2_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389238.298387300921604, 5860147.714495398104191 ], [ 1389210.947846550960094, 5860184.343885350972414 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_6_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 933.5, "elevtn_dn": 933.5, "invlev_up": 931.0, "invlev_dn": 931.0, "manhole_up": "manhole_2_generated", "manhole_dn": "manhole_3_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389210.947846550960094, 5860184.343885350972414 ], [ 1389186.961922727525234, 5860223.315261371433735 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_6_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 933.5, "elevtn_dn": 935.5, "invlev_up": 931.0, "invlev_dn": 933.0, "manhole_up": "manhole_3_generated", "manhole_dn": "manhole_4_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389186.961922727525234, 5860223.315261371433735 ], [ 1389162.755598766496405, 5860262.142883376218379 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_6_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 935.5, "invlev_up": 933.0, "invlev_dn": 933.0, "manhole_up": "manhole_4_generated", "manhole_dn": "manhole_5_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389162.755598766496405, 5860262.142883376218379 ], [ 1389136.759307563304901, 5860299.80301527120173 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_6_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 936.5, "invlev_up": 933.0, "invlev_dn": 934.0, "manhole_up": "manhole_5_generated", "manhole_dn": "manhole_6_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389136.759307563304901, 5860299.80301527120173 ], [ 1389109.7301227634307, 5860336.652257356792688 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_6_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 936.5, "elevtn_dn": 941.10003662109375, "invlev_up": 934.0, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_6_generated", "manhole_dn": "manhole_7_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389109.7301227634307, 5860336.652257356792688 ], [ 1389073.18478828552179, 5860363.522737024351954 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_6_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_7_generated", "manhole_dn": "manhole_8_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389073.18478828552179, 5860363.522737024351954 ], [ 1389032.546542100608349, 5860384.329287325032055 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_6_E8", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_8_generated", "manhole_dn": "manhole_9_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389032.546542100608349, 5860384.329287325032055 ], [ 1388989.578410296700895, 5860400.071978960186243 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_6_E9", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 951.29998779296875, "invlev_up": 938.60003662109375, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_9_generated", "manhole_dn": "manhole_10_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388989.578410296700895, 5860400.071978960186243 ], [ 1388946.301100668497384, 5860414.883977899327874 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_7_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_11_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389221.905703959986567, 5860123.3256367566064 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_7_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_11_generated", "manhole_dn": "manhole_12_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389221.905703959986567, 5860123.3256367566064 ], [ 1389177.295895804418251, 5860134.962970778346062 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_7_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 919.60003662109375, "invlev_up": 913.4000244140625, "invlev_dn": 917.10003662109375, "manhole_up": "manhole_12_generated", "manhole_dn": "manhole_13_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389177.295895804418251, 5860134.962970778346062 ], [ 1389132.686087648617104, 5860146.600304800085723 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_7_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 919.60003662109375, "elevtn_dn": 919.60003662109375, "invlev_up": 917.10003662109375, "invlev_dn": 917.10003662109375, "manhole_up": "manhole_13_generated", "manhole_dn": "manhole_14_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389132.686087648617104, 5860146.600304800085723 ], [ 1389088.076279493048787, 5860158.237638821825385 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_7_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 919.60003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 917.10003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_14_generated", "manhole_dn": "manhole_15_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389088.076279493048787, 5860158.237638821825385 ], [ 1389044.226173994829878, 5860172.143308508209884 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_7_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 935.60003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_15_generated", "manhole_dn": "manhole_16_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389044.226173994829878, 5860172.143308508209884 ], [ 1389012.527182487538084, 5860198.239755615592003 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_7_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 935.60003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_16_generated", "manhole_dn": "manhole_17_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389012.527182487538084, 5860198.239755615592003 ], [ 1388995.773122631013393, 5860240.481283166445792 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_7_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 945.0, "invlev_up": 935.60003662109375, "invlev_dn": 942.5, "manhole_up": "manhole_17_generated", "manhole_dn": "manhole_18_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388995.773122631013393, 5860240.481283166445792 ], [ 1388973.630034049740061, 5860280.918223639950156 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_7_E8", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.0, "elevtn_dn": 951.29998779296875, "invlev_up": 942.5, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_18_generated", "manhole_dn": "manhole_19_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388973.630034049740061, 5860280.918223639950156 ], [ 1388961.171157888136804, 5860324.081192856654525 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_7_E9", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_19_generated", "manhole_dn": "manhole_20_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388961.171157888136804, 5860324.081192856654525 ], [ 1388955.410555170848966, 5860369.690168970264494 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_7_E10", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_20_generated", "manhole_dn": "manhole_10_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388955.410555170848966, 5860369.690168970264494 ], [ 1388946.301100668497384, 5860414.883977899327874 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 914.5, "invlev_up": 913.4000244140625, "invlev_dn": 912.0, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_21_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389306.50000010849908, 5860083.476415127515793 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 914.5, "elevtn_dn": 914.5, "invlev_up": 912.0, "invlev_dn": 912.0, "manhole_up": "manhole_21_generated", "manhole_dn": "manhole_22_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389306.50000010849908, 5860083.476415127515793 ], [ 1389355.420758404070511, 5860074.630405306816101 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 914.5, "elevtn_dn": 929.9000244140625, "invlev_up": 912.0, "invlev_dn": 927.4000244140625, "manhole_up": "manhole_22_generated", "manhole_dn": "manhole_23_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389355.420758404070511, 5860074.630405306816101 ], [ 1389389.090761042200029, 5860042.4449307853356 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 929.9000244140625, "elevtn_dn": 955.0, "invlev_up": 927.4000244140625, "invlev_dn": 952.5, "manhole_up": "manhole_23_generated", "manhole_dn": "manhole_24_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389389.090761042200029, 5860042.4449307853356 ], [ 1389404.036260401364416, 5859994.775433851405978 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_24_generated", "manhole_dn": "manhole_25_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389404.036260401364416, 5859994.775433851405978 ], [ 1389418.744130451697856, 5859947.032028519548476 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_25_generated", "manhole_dn": "manhole_26_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389418.744130451697856, 5859947.032028519548476 ], [ 1389423.265342897269875, 5859897.853969652205706 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 975.29998779296875, "invlev_up": 952.5, "invlev_dn": 972.79998779296875, "manhole_up": "manhole_26_generated", "manhole_dn": "manhole_27_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389423.265342897269875, 5859897.853969652205706 ], [ 1389395.831073811277747, 5859856.743154510855675 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 975.29998779296875, "elevtn_dn": 963.0, "invlev_up": 972.79998779296875, "invlev_dn": 960.5, "manhole_up": "manhole_27_generated", "manhole_dn": "manhole_28_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389395.831073811277747, 5859856.743154510855675 ], [ 1389350.827042841585353, 5859839.640478814020753 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E8", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 963.0, "elevtn_dn": 963.0, "invlev_up": 960.5, "invlev_dn": 960.5, "manhole_up": "manhole_28_generated", "manhole_dn": "manhole_29_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389350.827042841585353, 5859839.640478814020753 ], [ 1389303.795788601972163, 5859855.887689013034105 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E9", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 963.0, "elevtn_dn": 945.4000244140625, "invlev_up": 960.5, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_29_generated", "manhole_dn": "manhole_30_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389303.795788601972163, 5859855.887689013034105 ], [ 1389256.284586790716276, 5859863.631580747663975 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E10", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 945.4000244140625, "invlev_up": 942.9000244140625, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_30_generated", "manhole_dn": "manhole_31_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389256.284586790716276, 5859863.631580747663975 ], [ 1389227.308454349869862, 5859823.781623384915292 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E11", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 945.4000244140625, "invlev_up": 942.9000244140625, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_31_generated", "manhole_dn": "manhole_32_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389227.308454349869862, 5859823.781623384915292 ], [ 1389202.745489193825051, 5859780.279727600514889 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E12", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 959.10003662109375, "invlev_up": 942.9000244140625, "invlev_dn": 956.60003662109375, "manhole_up": "manhole_32_generated", "manhole_dn": "manhole_33_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389202.745489193825051, 5859780.279727600514889 ], [ 1389178.18252403778024, 5859736.777831817045808 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E13", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 959.10003662109375, "elevtn_dn": 944.79998779296875, "invlev_up": 956.60003662109375, "invlev_dn": 942.29998779296875, "manhole_up": "manhole_33_generated", "manhole_dn": "manhole_34_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389178.18252403778024, 5859736.777831817045808 ], [ 1389155.231297271326184, 5859692.450142606161535 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E14", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 944.79998779296875, "elevtn_dn": 944.79998779296875, "invlev_up": 942.29998779296875, "invlev_dn": 942.29998779296875, "manhole_up": "manhole_34_generated", "manhole_dn": "manhole_35_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389155.231297271326184, 5859692.450142606161535 ], [ 1389141.413412723457441, 5859644.883844587020576 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E15", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 944.79998779296875, "elevtn_dn": 952.4000244140625, "invlev_up": 942.29998779296875, "invlev_dn": 949.9000244140625, "manhole_up": "manhole_35_generated", "manhole_dn": "manhole_36_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389141.413412723457441, 5859644.883844587020576 ], [ 1389151.802280035568401, 5859598.61804121825844 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E16", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.4000244140625, "elevtn_dn": 960.70001220703125, "invlev_up": 949.9000244140625, "invlev_dn": 958.20001220703125, "manhole_up": "manhole_36_generated", "manhole_dn": "manhole_37_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389151.802280035568401, 5859598.61804121825844 ], [ 1389191.073854762827978, 5859569.046822287142277 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E17", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 960.70001220703125, "elevtn_dn": 960.70001220703125, "invlev_up": 958.20001220703125, "invlev_dn": 958.20001220703125, "manhole_up": "manhole_37_generated", "manhole_dn": "manhole_38_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389191.073854762827978, 5859569.046822287142277 ], [ 1389239.915165816899389, 5859563.955490378662944 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E18", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 960.70001220703125, "elevtn_dn": 969.60003662109375, "invlev_up": 958.20001220703125, "invlev_dn": 967.10003662109375, "manhole_up": "manhole_38_generated", "manhole_dn": "manhole_39_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389239.915165816899389, 5859563.955490378662944 ], [ 1389289.757686472963542, 5859566.285022127442062 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E19", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 969.60003662109375, "elevtn_dn": 969.60003662109375, "invlev_up": 967.10003662109375, "invlev_dn": 967.10003662109375, "manhole_up": "manhole_39_generated", "manhole_dn": "manhole_40_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389289.757686472963542, 5859566.285022127442062 ], [ 1389339.615828452631831, 5859566.079234052449465 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E20", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 969.60003662109375, "elevtn_dn": 976.29998779296875, "invlev_up": 967.10003662109375, "invlev_dn": 973.79998779296875, "manhole_up": "manhole_40_generated", "manhole_dn": "manhole_41_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389339.615828452631831, 5859566.079234052449465 ], [ 1389387.354307833593339, 5859551.676988741382957 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E21", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 976.29998779296875, "elevtn_dn": 976.29998779296875, "invlev_up": 973.79998779296875, "invlev_dn": 973.79998779296875, "manhole_up": "manhole_41_generated", "manhole_dn": "manhole_42_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389387.354307833593339, 5859551.676988741382957 ], [ 1389428.692968821851537, 5859524.248876142315567 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E22", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 976.29998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 973.79998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_42_generated", "manhole_dn": "manhole_43_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389428.692968821851537, 5859524.248876142315567 ], [ 1389461.138921525795013, 5859486.477508954703808 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E23", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_43_generated", "manhole_dn": "manhole_44_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389461.138921525795013, 5859486.477508954703808 ], [ 1389482.45163832209073, 5859441.487986368127167 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E24", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_44_generated", "manhole_dn": "manhole_45_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389482.45163832209073, 5859441.487986368127167 ], [ 1389497.215460168197751, 5859393.906833835877478 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E25", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_45_generated", "manhole_dn": "manhole_46_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389497.215460168197751, 5859393.906833835877478 ], [ 1389508.394423164660111, 5859345.216126504354179 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E26", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 954.79998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_46_generated", "manhole_dn": "manhole_47_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389508.394423164660111, 5859345.216126504354179 ], [ 1389518.522437864448875, 5859296.29671473056078 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E27", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 954.79998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_47_generated", "manhole_dn": "manhole_48_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389518.522437864448875, 5859296.29671473056078 ], [ 1389528.588071504374966, 5859247.363727764226496 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E28", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 950.20001220703125, "invlev_up": 954.79998779296875, "invlev_dn": 947.70001220703125, "manhole_up": "manhole_48_generated", "manhole_dn": "manhole_49_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389528.588071504374966, 5859247.363727764226496 ], [ 1389538.653705144301057, 5859198.43074079696089 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E29", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 950.20001220703125, "elevtn_dn": 957.60003662109375, "invlev_up": 947.70001220703125, "invlev_dn": 955.10003662109375, "manhole_up": "manhole_49_generated", "manhole_dn": "manhole_50_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389538.653705144301057, 5859198.43074079696089 ], [ 1389548.719338784459978, 5859149.497753830626607 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E30", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.60003662109375, "elevtn_dn": 957.60003662109375, "invlev_up": 955.10003662109375, "invlev_dn": 955.10003662109375, "manhole_up": "manhole_50_generated", "manhole_dn": "manhole_51_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389548.719338784459978, 5859149.497753830626607 ], [ 1389558.784972424386069, 5859100.564766863361001 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E31", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.60003662109375, "elevtn_dn": 954.79998779296875, "invlev_up": 955.10003662109375, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_51_generated", "manhole_dn": "manhole_52_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389558.784972424386069, 5859100.564766863361001 ], [ 1389568.85060606431216, 5859051.631779897026718 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E32", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 954.79998779296875, "invlev_up": 952.29998779296875, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_52_generated", "manhole_dn": "manhole_53_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389568.85060606431216, 5859051.631779897026718 ], [ 1389578.916239704471081, 5859002.698792929761112 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E33", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 954.79998779296875, "invlev_up": 952.29998779296875, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_53_generated", "manhole_dn": "manhole_54_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389578.916239704471081, 5859002.698792929761112 ], [ 1389588.981873344397172, 5858953.765805963426828 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E34", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 956.10003662109375, "invlev_up": 952.29998779296875, "invlev_dn": 953.60003662109375, "manhole_up": "manhole_54_generated", "manhole_dn": "manhole_55_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389588.981873344397172, 5858953.765805963426828 ], [ 1389599.047506984323263, 5858904.832818996161222 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E35", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 956.10003662109375, "elevtn_dn": 956.10003662109375, "invlev_up": 953.60003662109375, "invlev_dn": 953.60003662109375, "manhole_up": "manhole_55_generated", "manhole_dn": "manhole_56_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389599.047506984323263, 5858904.832818996161222 ], [ 1389613.243873829254881, 5858857.048414096236229 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E36", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 956.10003662109375, "elevtn_dn": 966.29998779296875, "invlev_up": 953.60003662109375, "invlev_dn": 963.79998779296875, "manhole_up": "manhole_56_generated", "manhole_dn": "manhole_57_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389613.243873829254881, 5858857.048414096236229 ], [ 1389631.198101107496768, 5858810.554778259247541 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E37", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 966.29998779296875, "elevtn_dn": 968.70001220703125, "invlev_up": 963.79998779296875, "invlev_dn": 966.20001220703125, "manhole_up": "manhole_57_generated", "manhole_dn": "manhole_58_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389631.198101107496768, 5858810.554778259247541 ], [ 1389656.490605737781152, 5858767.472956065088511 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E38", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 968.70001220703125, "elevtn_dn": 968.70001220703125, "invlev_up": 966.20001220703125, "invlev_dn": 966.20001220703125, "manhole_up": "manhole_58_generated", "manhole_dn": "manhole_59_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389656.490605737781152, 5858767.472956065088511 ], [ 1389681.956975018838421, 5858724.49639992788434 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E39", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 968.70001220703125, "elevtn_dn": 976.10003662109375, "invlev_up": 966.20001220703125, "invlev_dn": 973.60003662109375, "manhole_up": "manhole_59_generated", "manhole_dn": "manhole_60_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389681.956975018838421, 5858724.49639992788434 ], [ 1389708.407580326776952, 5858682.115747822448611 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E40", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 976.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 973.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_60_generated", "manhole_dn": "manhole_61_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389708.407580326776952, 5858682.115747822448611 ], [ 1389734.858185634715483, 5858639.735095717012882 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E41", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 980.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_61_generated", "manhole_dn": "manhole_62_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389734.858185634715483, 5858639.735095717012882 ], [ 1389761.308790942654014, 5858597.354443610645831 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E42", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 980.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_62_generated", "manhole_dn": "manhole_63_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389761.308790942654014, 5858597.354443610645831 ], [ 1389787.759396250825375, 5858554.973791505210102 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E43", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 993.29998779296875, "invlev_up": 980.60003662109375, "invlev_dn": 990.79998779296875, "manhole_up": "manhole_63_generated", "manhole_dn": "manhole_64_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389787.759396250825375, 5858554.973791505210102 ], [ 1389814.210001558763906, 5858512.593139399774373 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E44", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 993.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 990.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_64_generated", "manhole_dn": "manhole_65_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389814.210001558763906, 5858512.593139399774373 ], [ 1389840.660606866702437, 5858470.212487293407321 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E45", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 995.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_65_generated", "manhole_dn": "manhole_66_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389840.660606866702437, 5858470.212487293407321 ], [ 1389867.111212174640968, 5858427.831835187971592 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E46", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 995.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_66_generated", "manhole_dn": "manhole_67_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389867.111212174640968, 5858427.831835187971592 ], [ 1389911.240854029776528, 5858417.074701879173517 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E47", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 1006.2000122070312, "invlev_up": 995.79998779296875, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_67_generated", "manhole_dn": "manhole_68_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389911.240854029776528, 5858417.074701879173517 ], [ 1389940.226093058940023, 5858455.739661679603159 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E48", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1006.2000122070312, "invlev_up": 1003.7000122070312, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_68_generated", "manhole_dn": "manhole_69_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389940.226093058940023, 5858455.739661679603159 ], [ 1389959.842267287895083, 5858501.684845351614058 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E49", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1006.2000122070312, "invlev_up": 1003.7000122070312, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_69_generated", "manhole_dn": "manhole_70_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389959.842267287895083, 5858501.684845351614058 ], [ 1389983.028926897095516, 5858544.760824581608176 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E50", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1036.9000244140625, "invlev_up": 1003.7000122070312, "invlev_dn": 1034.4000244140625, "manhole_up": "manhole_70_generated", "manhole_dn": "manhole_71_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389983.028926897095516, 5858544.760824581608176 ], [ 1390026.879799408372492, 5858567.986969069577754 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E51", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1036.9000244140625, "elevtn_dn": 1036.9000244140625, "invlev_up": 1034.4000244140625, "invlev_dn": 1034.4000244140625, "manhole_up": "manhole_71_generated", "manhole_dn": "manhole_72_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390026.879799408372492, 5858567.986969069577754 ], [ 1390075.455719914287329, 5858577.981817713007331 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E52", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1036.9000244140625, "elevtn_dn": 1032.9000244140625, "invlev_up": 1034.4000244140625, "invlev_dn": 1030.4000244140625, "manhole_up": "manhole_72_generated", "manhole_dn": "manhole_73_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390075.455719914287329, 5858577.981817713007331 ], [ 1390124.934819511603564, 5858584.860858413390815 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E53", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1032.9000244140625, "elevtn_dn": 1032.9000244140625, "invlev_up": 1030.4000244140625, "invlev_dn": 1030.4000244140625, "manhole_up": "manhole_73_generated", "manhole_dn": "manhole_74_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390124.934819511603564, 5858584.860858413390815 ], [ 1390174.385966305155307, 5858591.894069475121796 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E54", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1032.9000244140625, "elevtn_dn": 1016.6000366210938, "invlev_up": 1030.4000244140625, "invlev_dn": 1014.1000366210938, "manhole_up": "manhole_74_generated", "manhole_dn": "manhole_75_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390174.385966305155307, 5858591.894069475121796 ], [ 1390224.28731826832518, 5858594.262458441779017 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E55", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1016.6000366210938, "elevtn_dn": 1016.6000366210938, "invlev_up": 1014.1000366210938, "invlev_dn": 1014.1000366210938, "manhole_up": "manhole_75_generated", "manhole_dn": "manhole_76_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390224.28731826832518, 5858594.262458441779017 ], [ 1390273.630285855382681, 5858589.561945637688041 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E56", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1016.6000366210938, "elevtn_dn": 1012.1000366210938, "invlev_up": 1014.1000366210938, "invlev_dn": 1009.6000366210938, "manhole_up": "manhole_76_generated", "manhole_dn": "manhole_77_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390273.630285855382681, 5858589.561945637688041 ], [ 1390322.239480242831632, 5858578.072306710295379 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E57", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1012.1000366210938, "elevtn_dn": 1012.1000366210938, "invlev_up": 1009.6000366210938, "invlev_dn": 1009.6000366210938, "manhole_up": "manhole_77_generated", "manhole_dn": "manhole_78_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390322.239480242831632, 5858578.072306710295379 ], [ 1390371.99352877959609, 5858575.309522898867726 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E58", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1012.1000366210938, "elevtn_dn": 1011.7000122070312, "invlev_up": 1009.6000366210938, "invlev_dn": 1009.2000122070312, "manhole_up": "manhole_78_generated", "manhole_dn": "manhole_79_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390371.99352877959609, 5858575.309522898867726 ], [ 1390419.13544210139662, 5858559.59311543405056 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E59", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1011.7000122070312, "elevtn_dn": 981.5, "invlev_up": 1009.2000122070312, "invlev_dn": 979.0, "manhole_up": "manhole_79_generated", "manhole_dn": "manhole_80_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390419.13544210139662, 5858559.59311543405056 ], [ 1390453.401623640675098, 5858524.246223840862513 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E60", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 981.5, "elevtn_dn": 995.70001220703125, "invlev_up": 979.0, "invlev_dn": 993.20001220703125, "manhole_up": "manhole_80_generated", "manhole_dn": "manhole_81_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390453.401623640675098, 5858524.246223840862513 ], [ 1390496.749499944737181, 5858504.780008735135198 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E61", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 995.70001220703125, "elevtn_dn": 995.70001220703125, "invlev_up": 993.20001220703125, "invlev_dn": 993.20001220703125, "manhole_up": "manhole_81_generated", "manhole_dn": "manhole_82_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390496.749499944737181, 5858504.780008735135198 ], [ 1390546.470755147282034, 5858499.993151630274951 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E62", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 995.70001220703125, "elevtn_dn": 1005.9000244140625, "invlev_up": 993.20001220703125, "invlev_dn": 1003.4000244140625, "manhole_up": "manhole_82_generated", "manhole_dn": "manhole_83_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390546.470755147282034, 5858499.993151630274951 ], [ 1390596.395264241611585, 5858498.177226040512323 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E63", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1005.9000244140625, "elevtn_dn": 1005.9000244140625, "invlev_up": 1003.4000244140625, "invlev_dn": 1003.4000244140625, "manhole_up": "manhole_83_generated", "manhole_dn": "manhole_84_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390596.395264241611585, 5858498.177226040512323 ], [ 1390646.319773336173967, 5858496.361300451681018 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E64", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1005.9000244140625, "elevtn_dn": 1013.6000366210938, "invlev_up": 1003.4000244140625, "invlev_dn": 1011.1000366210938, "manhole_up": "manhole_84_generated", "manhole_dn": "manhole_85_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390646.319773336173967, 5858496.361300451681018 ], [ 1390696.244282430503517, 5858494.545374862849712 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E65", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1013.6000366210938, "elevtn_dn": 1013.6000366210938, "invlev_up": 1011.1000366210938, "invlev_dn": 1011.1000366210938, "manhole_up": "manhole_85_generated", "manhole_dn": "manhole_86_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390696.244282430503517, 5858494.545374862849712 ], [ 1390746.168791524833068, 5858492.729449273087084 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E66", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1013.6000366210938, "elevtn_dn": 1019.1000366210938, "invlev_up": 1011.1000366210938, "invlev_dn": 1016.6000366210938, "manhole_up": "manhole_86_generated", "manhole_dn": "manhole_87_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390746.168791524833068, 5858492.729449273087084 ], [ 1390796.09330061939545, 5858490.913523684255779 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E67", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1019.1000366210938, "elevtn_dn": 1025.800048828125, "invlev_up": 1016.6000366210938, "invlev_dn": 1023.300048828125, "manhole_up": "manhole_87_generated", "manhole_dn": "manhole_88_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390796.09330061939545, 5858490.913523684255779 ], [ 1390846.017809713725001, 5858489.097598095424473 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E68", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1025.800048828125, "elevtn_dn": 1025.800048828125, "invlev_up": 1023.300048828125, "invlev_dn": 1023.300048828125, "manhole_up": "manhole_88_generated", "manhole_dn": "manhole_89_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390846.017809713725001, 5858489.097598095424473 ], [ 1390895.942318808054551, 5858487.281672505661845 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E69", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1025.800048828125, "elevtn_dn": 1029.2000732421875, "invlev_up": 1023.300048828125, "invlev_dn": 1026.7000732421875, "manhole_up": "manhole_89_generated", "manhole_dn": "manhole_90_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390895.942318808054551, 5858487.281672505661845 ], [ 1390945.364988021552563, 5858492.061225635930896 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E70", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1029.2000732421875, "elevtn_dn": 1029.2000732421875, "invlev_up": 1026.7000732421875, "invlev_dn": 1026.7000732421875, "manhole_up": "manhole_90_generated", "manhole_dn": "manhole_91_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390945.364988021552563, 5858492.061225635930896 ], [ 1390994.440001817885786, 5858501.409873396158218 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E71", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1029.2000732421875, "elevtn_dn": 1033.2000732421875, "invlev_up": 1026.7000732421875, "invlev_dn": 1030.7000732421875, "manhole_up": "manhole_91_generated", "manhole_dn": "manhole_92_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390994.440001817885786, 5858501.409873396158218 ], [ 1391040.341196772176772, 5858520.979841153137386 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E72", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1033.2000732421875, "elevtn_dn": 1033.2000732421875, "invlev_up": 1030.7000732421875, "invlev_dn": 1030.7000732421875, "manhole_up": "manhole_92_generated", "manhole_dn": "manhole_93_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391040.341196772176772, 5858520.979841153137386 ], [ 1391086.683747049886733, 5858538.717575071379542 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E73", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1033.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1030.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_93_generated", "manhole_dn": "manhole_94_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391086.683747049886733, 5858538.717575071379542 ], [ 1391131.822940095094964, 5858523.93243224080652 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E74", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_94_generated", "manhole_dn": "manhole_95_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391131.822940095094964, 5858523.93243224080652 ], [ 1391153.157672074623406, 5858479.460670891217887 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E75", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_95_generated", "manhole_dn": "manhole_96_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391153.157672074623406, 5858479.460670891217887 ], [ 1391192.49590603238903, 5858451.67839205916971 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E76", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1044.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1041.7000732421875, "manhole_up": "manhole_96_generated", "manhole_dn": "manhole_97_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391192.49590603238903, 5858451.67839205916971 ], [ 1391240.64117361814715, 5858438.460245226509869 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E77", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1044.2000732421875, "elevtn_dn": 1044.2000732421875, "invlev_up": 1041.7000732421875, "invlev_dn": 1041.7000732421875, "manhole_up": "manhole_97_generated", "manhole_dn": "manhole_98_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391240.64117361814715, 5858438.460245226509869 ], [ 1391289.211760010803118, 5858426.770406410098076 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E78", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1044.2000732421875, "elevtn_dn": 1060.0999755859375, "invlev_up": 1041.7000732421875, "invlev_dn": 1057.5999755859375, "manhole_up": "manhole_98_generated", "manhole_dn": "manhole_99_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391289.211760010803118, 5858426.770406410098076 ], [ 1391337.782346403226256, 5858415.080567593686283 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E79", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1060.0999755859375, "elevtn_dn": 1023.0, "invlev_up": 1057.5999755859375, "invlev_dn": 1020.5, "manhole_up": "manhole_99_generated", "manhole_dn": "manhole_100_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391337.782346403226256, 5858415.080567593686283 ], [ 1391386.352932795882225, 5858403.390728777274489 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E80", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1023.0, "elevtn_dn": 1032.7000732421875, "invlev_up": 1020.5, "invlev_dn": 1030.2000732421875, "manhole_up": "manhole_100_generated", "manhole_dn": "manhole_101_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391386.352932795882225, 5858403.390728777274489 ], [ 1391434.923519188305363, 5858391.700889961794019 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E81", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1032.7000732421875, "elevtn_dn": 1032.7000732421875, "invlev_up": 1030.2000732421875, "invlev_dn": 1030.2000732421875, "manhole_up": "manhole_101_generated", "manhole_dn": "manhole_102_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391434.923519188305363, 5858391.700889961794019 ], [ 1391483.494105580961332, 5858380.011051145382226 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E82", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1032.7000732421875, "elevtn_dn": 1040.7000732421875, "invlev_up": 1030.2000732421875, "invlev_dn": 1038.2000732421875, "manhole_up": "manhole_102_generated", "manhole_dn": "manhole_103_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391483.494105580961332, 5858380.011051145382226 ], [ 1391532.464345134794712, 5858375.802092345431447 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E83", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1040.7000732421875, "elevtn_dn": 1040.7000732421875, "invlev_up": 1038.2000732421875, "invlev_dn": 1038.2000732421875, "manhole_up": "manhole_103_generated", "manhole_dn": "manhole_104_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391532.464345134794712, 5858375.802092345431447 ], [ 1391579.680508555145934, 5858389.753166117705405 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E84", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1040.7000732421875, "elevtn_dn": 1094.5999755859375, "invlev_up": 1038.2000732421875, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_104_generated", "manhole_dn": "manhole_105_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391579.680508555145934, 5858389.753166117705405 ], [ 1391615.043221722124144, 5858422.374543751589954 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E85", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1094.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_105_generated", "manhole_dn": "manhole_106_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391615.043221722124144, 5858422.374543751589954 ], [ 1391633.654095822479576, 5858468.206737855449319 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E86", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1094.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_106_generated", "manhole_dn": "manhole_107_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391633.654095822479576, 5858468.206737855449319 ], [ 1391675.556871910346672, 5858492.042518986389041 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E87", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1100.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1098.0999755859375, "manhole_up": "manhole_107_generated", "manhole_dn": "manhole_108_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391675.556871910346672, 5858492.042518986389041 ], [ 1391725.165284683462232, 5858493.223410680890083 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E88", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1100.5999755859375, "elevtn_dn": 1092.7000732421875, "invlev_up": 1098.0999755859375, "invlev_dn": 1090.2000732421875, "manhole_up": "manhole_108_generated", "manhole_dn": "manhole_109_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391725.165284683462232, 5858493.223410680890083 ], [ 1391774.025632579578087, 5858482.968163449317217 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E89", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1092.7000732421875, "elevtn_dn": 1092.7000732421875, "invlev_up": 1090.2000732421875, "invlev_dn": 1090.2000732421875, "manhole_up": "manhole_109_generated", "manhole_dn": "manhole_110_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391774.025632579578087, 5858482.968163449317217 ], [ 1391822.748904443578795, 5858472.800456050783396 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E90", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1092.7000732421875, "elevtn_dn": 1086.5, "invlev_up": 1090.2000732421875, "invlev_dn": 1084.0, "manhole_up": "manhole_110_generated", "manhole_dn": "manhole_111_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391822.748904443578795, 5858472.800456050783396 ], [ 1391872.520155652426183, 5858474.254766616038978 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E91", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1086.5, "elevtn_dn": 1086.5, "invlev_up": 1084.0, "invlev_dn": 1084.0, "manhole_up": "manhole_111_generated", "manhole_dn": "manhole_112_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391872.520155652426183, 5858474.254766616038978 ], [ 1391922.32820742437616, 5858478.116394865326583 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E92", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1086.5, "elevtn_dn": 1097.300048828125, "invlev_up": 1084.0, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_112_generated", "manhole_dn": "manhole_113_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391922.32820742437616, 5858478.116394865326583 ], [ 1391972.136259196558967, 5858481.978023114614189 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E93", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_113_generated", "manhole_dn": "manhole_114_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391972.136259196558967, 5858481.978023114614189 ], [ 1392014.088137687649578, 5858507.265420926734805 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E94", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_114_generated", "manhole_dn": "manhole_115_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392014.088137687649578, 5858507.265420926734805 ], [ 1392052.00577615830116, 5858538.949620860628784 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E95", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_115_generated", "manhole_dn": "manhole_116_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392052.00577615830116, 5858538.949620860628784 ], [ 1392100.993319420609623, 5858548.746293722651899 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E96", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1135.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1132.800048828125, "manhole_up": "manhole_116_generated", "manhole_dn": "manhole_117_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392100.993319420609623, 5858548.746293722651899 ], [ 1392149.980862683150917, 5858558.542966585606337 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E97", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1135.300048828125, "elevtn_dn": 1135.300048828125, "invlev_up": 1132.800048828125, "invlev_dn": 1132.800048828125, "manhole_up": "manhole_117_generated", "manhole_dn": "manhole_118_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392149.980862683150917, 5858558.542966585606337 ], [ 1392198.767287699971348, 5858569.25206732749939 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E98", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1135.300048828125, "elevtn_dn": 1137.5999755859375, "invlev_up": 1132.800048828125, "invlev_dn": 1135.0999755859375, "manhole_up": "manhole_118_generated", "manhole_dn": "manhole_119_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392198.767287699971348, 5858569.25206732749939 ], [ 1392247.333906656363979, 5858580.958378325216472 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E99", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1137.5999755859375, "elevtn_dn": 1137.5999755859375, "invlev_up": 1135.0999755859375, "invlev_dn": 1135.0999755859375, "manhole_up": "manhole_119_generated", "manhole_dn": "manhole_120_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392247.333906656363979, 5858580.958378325216472 ], [ 1392295.900525612989441, 5858592.664689323864877 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E100", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1137.5999755859375, "elevtn_dn": 1145.0999755859375, "invlev_up": 1135.0999755859375, "invlev_dn": 1142.5999755859375, "manhole_up": "manhole_120_generated", "manhole_dn": "manhole_121_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392295.900525612989441, 5858592.664689323864877 ], [ 1392344.467144569614902, 5858604.371000322513282 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E101", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1145.0999755859375, "elevtn_dn": 1145.0999755859375, "invlev_up": 1142.5999755859375, "invlev_dn": 1142.5999755859375, "manhole_up": "manhole_121_generated", "manhole_dn": "manhole_122_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392344.467144569614902, 5858604.371000322513282 ], [ 1392389.908255772199482, 5858624.575613909401 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E102", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1145.0999755859375, "elevtn_dn": 1140.5, "invlev_up": 1142.5999755859375, "invlev_dn": 1138.0, "manhole_up": "manhole_122_generated", "manhole_dn": "manhole_123_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392389.908255772199482, 5858624.575613909401 ], [ 1392425.081700494978577, 5858659.315580372698605 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E103", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1140.5, "elevtn_dn": 1169.300048828125, "invlev_up": 1138.0, "invlev_dn": 1166.800048828125, "manhole_up": "manhole_123_generated", "manhole_dn": "manhole_124_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392425.081700494978577, 5858659.315580372698605 ], [ 1392458.203119478421286, 5858696.715123130939901 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E104", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1169.300048828125, "elevtn_dn": 1169.300048828125, "invlev_up": 1166.800048828125, "invlev_dn": 1166.800048828125, "manhole_up": "manhole_124_generated", "manhole_dn": "manhole_125_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392458.203119478421286, 5858696.715123130939901 ], [ 1392491.324538461863995, 5858734.114665890112519 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E105", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1169.300048828125, "elevtn_dn": 1165.5, "invlev_up": 1166.800048828125, "invlev_dn": 1163.0, "manhole_up": "manhole_125_generated", "manhole_dn": "manhole_126_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392491.324538461863995, 5858734.114665890112519 ], [ 1392528.963966277893633, 5858766.460637149401009 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E106", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1165.5, "elevtn_dn": 1165.5, "invlev_up": 1163.0, "invlev_dn": 1163.0, "manhole_up": "manhole_126_generated", "manhole_dn": "manhole_127_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392528.963966277893633, 5858766.460637149401009 ], [ 1392573.284122244687751, 5858789.391092935577035 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E107", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1165.5, "elevtn_dn": 1157.0999755859375, "invlev_up": 1163.0, "invlev_dn": 1154.5999755859375, "manhole_up": "manhole_127_generated", "manhole_dn": "manhole_128_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392573.284122244687751, 5858789.391092935577035 ], [ 1392618.033192394766957, 5858811.600886153057218 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E108", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1157.0999755859375, "elevtn_dn": 1184.800048828125, "invlev_up": 1154.5999755859375, "invlev_dn": 1182.300048828125, "manhole_up": "manhole_128_generated", "manhole_dn": "manhole_129_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392618.033192394766957, 5858811.600886153057218 ], [ 1392666.730896146036685, 5858821.011833874508739 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E109", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1184.800048828125, "elevtn_dn": 1141.2000732421875, "invlev_up": 1182.300048828125, "invlev_dn": 1138.7000732421875, "manhole_up": "manhole_129_generated", "manhole_dn": "manhole_130_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392666.730896146036685, 5858821.011833874508739 ], [ 1392714.397227015113458, 5858809.184477739967406 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E110", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1141.2000732421875, "elevtn_dn": 1141.2000732421875, "invlev_up": 1138.7000732421875, "invlev_dn": 1138.7000732421875, "manhole_up": "manhole_130_generated", "manhole_dn": "manhole_131_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392714.397227015113458, 5858809.184477739967406 ], [ 1392761.799294820055366, 5858794.231293976306915 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E111", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1141.2000732421875, "elevtn_dn": 1137.4000244140625, "invlev_up": 1138.7000732421875, "invlev_dn": 1134.9000244140625, "manhole_up": "manhole_131_generated", "manhole_dn": "manhole_132_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392761.799294820055366, 5858794.231293976306915 ], [ 1392810.095712865469977, 5858797.830352782271802 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E112", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1137.4000244140625, "elevtn_dn": 1137.4000244140625, "invlev_up": 1134.9000244140625, "invlev_dn": 1134.9000244140625, "manhole_up": "manhole_132_generated", "manhole_dn": "manhole_133_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392810.095712865469977, 5858797.830352782271802 ], [ 1392855.660074200481176, 5858817.529770986177027 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E113", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1137.4000244140625, "elevtn_dn": 1169.5, "invlev_up": 1134.9000244140625, "invlev_dn": 1167.0, "manhole_up": "manhole_133_generated", "manhole_dn": "manhole_134_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392855.660074200481176, 5858817.529770986177027 ], [ 1392904.672455, 5858826.347064822912216 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E114", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_134_generated", "manhole_dn": "manhole_135_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392904.672455, 5858826.347064822912216 ], [ 1392949.505032581742853, 5858846.393358059227467 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E115", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_135_generated", "manhole_dn": "manhole_136_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392949.505032581742853, 5858846.393358059227467 ], [ 1392993.956312821945176, 5858868.358838438987732 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E116", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_136_generated", "manhole_dn": "manhole_137_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392993.956312821945176, 5858868.358838438987732 ], [ 1393042.160067020915449, 5858881.479519641026855 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E117", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1162.0, "invlev_up": 1167.0, "invlev_dn": 1159.5, "manhole_up": "manhole_137_generated", "manhole_dn": "manhole_138_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393042.160067020915449, 5858881.479519641026855 ], [ 1393090.363821219652891, 5858894.600200843065977 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E118", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1162.0, "elevtn_dn": 1162.0, "invlev_up": 1159.5, "invlev_dn": 1159.5, "manhole_up": "manhole_138_generated", "manhole_dn": "manhole_139_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393090.363821219652891, 5858894.600200843065977 ], [ 1393138.877780271228403, 5858905.382868006825447 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E119", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1162.0, "elevtn_dn": 1152.0999755859375, "invlev_up": 1159.5, "invlev_dn": 1149.5999755859375, "manhole_up": "manhole_139_generated", "manhole_dn": "manhole_140_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393138.877780271228403, 5858905.382868006825447 ], [ 1393188.835210436256602, 5858905.286093098111451 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E120", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1152.0999755859375, "elevtn_dn": 1152.0999755859375, "invlev_up": 1149.5999755859375, "invlev_dn": 1149.5999755859375, "manhole_up": "manhole_140_generated", "manhole_dn": "manhole_141_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393188.835210436256602, 5858905.286093098111451 ], [ 1393237.248238409170881, 5858916.599204055964947 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E121", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1152.0999755859375, "elevtn_dn": 1147.300048828125, "invlev_up": 1149.5999755859375, "invlev_dn": 1144.800048828125, "manhole_up": "manhole_141_generated", "manhole_dn": "manhole_142_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393237.248238409170881, 5858916.599204055964947 ], [ 1393278.15638761385344, 5858943.766047672368586 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E122", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1147.300048828125, "elevtn_dn": 1182.7000732421875, "invlev_up": 1144.800048828125, "invlev_dn": 1180.2000732421875, "manhole_up": "manhole_142_generated", "manhole_dn": "manhole_143_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393278.15638761385344, 5858943.766047672368586 ], [ 1393316.553906054003164, 5858975.725158606655896 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E123", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1182.7000732421875, "elevtn_dn": 1180.0999755859375, "invlev_up": 1180.2000732421875, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_143_generated", "manhole_dn": "manhole_144_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393316.553906054003164, 5858975.725158606655896 ], [ 1393354.951424494385719, 5859007.684269540011883 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E124", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1180.0999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_144_generated", "manhole_dn": "manhole_145_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393354.951424494385719, 5859007.684269540011883 ], [ 1393393.348942934535444, 5859039.643380474299192 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E125", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1180.0999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_145_generated", "manhole_dn": "manhole_146_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393393.348942934535444, 5859039.643380474299192 ], [ 1393431.746461374685168, 5859071.602491408586502 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E126", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_146_generated", "manhole_dn": "manhole_147_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393431.746461374685168, 5859071.602491408586502 ], [ 1393472.672340910183266, 5859100.089053857140243 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E127", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1200.0999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_147_generated", "manhole_dn": "manhole_148_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393472.672340910183266, 5859100.089053857140243 ], [ 1393507.678647378925234, 5859134.262682756409049 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E128", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1200.0999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_148_generated", "manhole_dn": "manhole_149_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393507.678647378925234, 5859134.262682756409049 ], [ 1393492.637579936999828, 5859179.667013085447252 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E129", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1232.300048828125, "invlev_up": 1200.0999755859375, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_149_generated", "manhole_dn": "manhole_150_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393492.637579936999828, 5859179.667013085447252 ], [ 1393472.727902054553851, 5859225.064155456610024 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E130", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_150_generated", "manhole_dn": "manhole_151_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393472.727902054553851, 5859225.064155456610024 ], [ 1393467.563765458529815, 5859274.587596206925809 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E131", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_151_generated", "manhole_dn": "manhole_152_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393467.563765458529815, 5859274.587596206925809 ], [ 1393473.51405850565061, 5859323.8850102070719 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E132", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_152_generated", "manhole_dn": "manhole_153_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393473.51405850565061, 5859323.8850102070719 ], [ 1393507.773820924572647, 5859356.614802500233054 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E133", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1214.800048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1212.300048828125, "manhole_up": "manhole_153_generated", "manhole_dn": "manhole_154_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393507.773820924572647, 5859356.614802500233054 ], [ 1393555.824224345618859, 5859349.253152369521558 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E134", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1214.800048828125, "elevtn_dn": 1214.800048828125, "invlev_up": 1212.300048828125, "invlev_dn": 1212.300048828125, "manhole_up": "manhole_154_generated", "manhole_dn": "manhole_155_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393555.824224345618859, 5859349.253152369521558 ], [ 1393591.00338595919311, 5859314.794959847815335 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E135", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1214.800048828125, "elevtn_dn": 1191.0999755859375, "invlev_up": 1212.300048828125, "invlev_dn": 1188.5999755859375, "manhole_up": "manhole_155_generated", "manhole_dn": "manhole_156_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393591.00338595919311, 5859314.794959847815335 ], [ 1393633.153639519121498, 5859288.066565420478582 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E136", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1191.0999755859375, "elevtn_dn": 1191.0999755859375, "invlev_up": 1188.5999755859375, "invlev_dn": 1188.5999755859375, "manhole_up": "manhole_156_generated", "manhole_dn": "manhole_157_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393633.153639519121498, 5859288.066565420478582 ], [ 1393673.123904188396409, 5859258.097712650895119 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E137", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1191.0999755859375, "elevtn_dn": 1144.300048828125, "invlev_up": 1188.5999755859375, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_157_generated", "manhole_dn": "manhole_158_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393673.123904188396409, 5859258.097712650895119 ], [ 1393720.523227575467899, 5859244.838272913359106 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E138", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1144.300048828125, "invlev_up": 1141.800048828125, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_158_generated", "manhole_dn": "manhole_159_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393720.523227575467899, 5859244.838272913359106 ], [ 1393765.710014625452459, 5859224.569284616038203 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E139", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1144.300048828125, "invlev_up": 1141.800048828125, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_159_generated", "manhole_dn": "manhole_160_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393765.710014625452459, 5859224.569284616038203 ], [ 1393806.409210936399177, 5859195.609256223775446 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E140", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1112.5, "invlev_up": 1141.800048828125, "invlev_dn": 1110.0, "manhole_up": "manhole_160_generated", "manhole_dn": "manhole_161_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393806.409210936399177, 5859195.609256223775446 ], [ 1393846.866742686368525, 5859166.301538489758968 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1045", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 968.29998779296875, "invlev_up": 965.79998779296875, "invlev_dn": 965.79998779296875, "manhole_up": "manhole_162_generated", "manhole_dn": "manhole_163_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388521.257592596346512, 5855362.027613477781415 ], [ 1388472.030306826578453, 5855370.543775821104646 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1046", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 968.29998779296875, "invlev_up": 965.79998779296875, "invlev_dn": 965.79998779296875, "manhole_up": "manhole_163_generated", "manhole_dn": "manhole_164_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388472.030306826578453, 5855370.543775821104646 ], [ 1388439.000347282737494, 5855407.802592809312046 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1047", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 964.5, "invlev_up": 965.79998779296875, "invlev_dn": 962.0, "manhole_up": "manhole_164_generated", "manhole_dn": "manhole_165_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388439.000347282737494, 5855407.802592809312046 ], [ 1388400.196091859601438, 5855436.014134516008198 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1048", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 964.5, "invlev_up": 962.0, "invlev_dn": 962.0, "manhole_up": "manhole_165_generated", "manhole_dn": "manhole_166_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388400.196091859601438, 5855436.014134516008198 ], [ 1388351.33823574683629, 5855446.634319253265858 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1049", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 981.9000244140625, "invlev_up": 962.0, "invlev_dn": 979.4000244140625, "manhole_up": "manhole_166_generated", "manhole_dn": "manhole_167_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388351.33823574683629, 5855446.634319253265858 ], [ 1388301.961881892289966, 5855453.847477887757123 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1050", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 981.9000244140625, "elevtn_dn": 981.9000244140625, "invlev_up": 979.4000244140625, "invlev_dn": 979.4000244140625, "manhole_up": "manhole_167_generated", "manhole_dn": "manhole_168_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388301.961881892289966, 5855453.847477887757123 ], [ 1388252.297577269142494, 5855451.260453455150127 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1051", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 981.9000244140625, "elevtn_dn": 973.70001220703125, "invlev_up": 979.4000244140625, "invlev_dn": 971.20001220703125, "manhole_up": "manhole_168_generated", "manhole_dn": "manhole_169_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388252.297577269142494, 5855451.260453455150127 ], [ 1388202.479659734526649, 5855455.508814659900963 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1052", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 973.70001220703125, "elevtn_dn": 961.70001220703125, "invlev_up": 971.20001220703125, "invlev_dn": 959.20001220703125, "manhole_up": "manhole_169_generated", "manhole_dn": "manhole_170_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388202.479659734526649, 5855455.508814659900963 ], [ 1388152.683455461403355, 5855460.015516467392445 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1053", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 961.70001220703125, "elevtn_dn": 961.70001220703125, "invlev_up": 959.20001220703125, "invlev_dn": 959.20001220703125, "manhole_up": "manhole_170_generated", "manhole_dn": "manhole_171_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388152.683455461403355, 5855460.015516467392445 ], [ 1388104.622611842118204, 5855473.253733876161277 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1054", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 961.70001220703125, "elevtn_dn": 945.79998779296875, "invlev_up": 959.20001220703125, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_171_generated", "manhole_dn": "manhole_172_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388104.622611842118204, 5855473.253733876161277 ], [ 1388057.00563437351957, 5855488.445189393125474 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1055", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 945.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_172_generated", "manhole_dn": "manhole_173_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388057.00563437351957, 5855488.445189393125474 ], [ 1388011.292356542311609, 5855508.700276436284184 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1056", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 945.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_173_generated", "manhole_dn": "manhole_174_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388011.292356542311609, 5855508.700276436284184 ], [ 1387969.221702651120722, 5855535.246164590120316 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1057", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 930.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 928.29998779296875, "manhole_up": "manhole_174_generated", "manhole_dn": "manhole_175_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.221702651120722, 5855535.246164590120316 ], [ 1387935.863196024205536, 5855572.491061648353934 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1058", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 930.79998779296875, "elevtn_dn": 957.10003662109375, "invlev_up": 928.29998779296875, "invlev_dn": 954.60003662109375, "manhole_up": "manhole_175_generated", "manhole_dn": "manhole_176_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387935.863196024205536, 5855572.491061648353934 ], [ 1387904.610231971368194, 5855611.432584651745856 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1059", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.10003662109375, "elevtn_dn": 947.4000244140625, "invlev_up": 954.60003662109375, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_176_generated", "manhole_dn": "manhole_177_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387904.610231971368194, 5855611.432584651745856 ], [ 1387869.335365027422085, 5855646.852918352000415 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1060", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 947.4000244140625, "invlev_up": 944.9000244140625, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_177_generated", "manhole_dn": "manhole_178_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387869.335365027422085, 5855646.852918352000415 ], [ 1387831.783288773847744, 5855679.735664095729589 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1061", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 947.4000244140625, "invlev_up": 944.9000244140625, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_178_generated", "manhole_dn": "manhole_179_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387831.783288773847744, 5855679.735664095729589 ], [ 1387791.509416193468496, 5855708.923279576934874 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1062", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 933.29998779296875, "invlev_up": 944.9000244140625, "invlev_dn": 930.79998779296875, "manhole_up": "manhole_179_generated", "manhole_dn": "manhole_180_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387791.509416193468496, 5855708.923279576934874 ], [ 1387742.459816947113723, 5855717.213657722808421 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1063", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 933.29998779296875, "elevtn_dn": 933.29998779296875, "invlev_up": 930.79998779296875, "invlev_dn": 930.79998779296875, "manhole_up": "manhole_180_generated", "manhole_dn": "manhole_181_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387742.459816947113723, 5855717.213657722808421 ], [ 1387692.500367184402421, 5855718.495403698645532 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1064", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 933.29998779296875, "elevtn_dn": 911.10003662109375, "invlev_up": 930.79998779296875, "invlev_dn": 908.60003662109375, "manhole_up": "manhole_181_generated", "manhole_dn": "manhole_182_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387692.500367184402421, 5855718.495403698645532 ], [ 1387642.500798417022452, 5855718.61967874225229 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1065", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 911.10003662109375, "elevtn_dn": 887.70001220703125, "invlev_up": 908.60003662109375, "invlev_dn": 885.20001220703125, "manhole_up": "manhole_182_generated", "manhole_dn": "manhole_183_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387642.500798417022452, 5855718.61967874225229 ], [ 1387592.501229649642482, 5855718.743953784927726 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1066", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 887.70001220703125, "elevtn_dn": 887.70001220703125, "invlev_up": 885.20001220703125, "invlev_dn": 885.20001220703125, "manhole_up": "manhole_183_generated", "manhole_dn": "manhole_184_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387592.501229649642482, 5855718.743953784927726 ], [ 1387542.501660882262513, 5855718.868228827603161 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1067", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 887.70001220703125, "elevtn_dn": 902.9000244140625, "invlev_up": 885.20001220703125, "invlev_dn": 900.4000244140625, "manhole_up": "manhole_184_generated", "manhole_dn": "manhole_185_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387542.501660882262513, 5855718.868228827603161 ], [ 1387492.651409652316943, 5855720.815255363471806 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1068", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 902.9000244140625, "elevtn_dn": 902.9000244140625, "invlev_up": 900.4000244140625, "invlev_dn": 900.4000244140625, "manhole_up": "manhole_185_generated", "manhole_dn": "manhole_186_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387492.651409652316943, 5855720.815255363471806 ], [ 1387448.867236748570576, 5855742.752516686916351 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1069", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 902.9000244140625, "elevtn_dn": 886.20001220703125, "invlev_up": 900.4000244140625, "invlev_dn": 883.70001220703125, "manhole_up": "manhole_186_generated", "manhole_dn": "manhole_187_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387448.867236748570576, 5855742.752516686916351 ], [ 1387402.432745414320379, 5855761.091833713464439 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1070", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 886.20001220703125, "elevtn_dn": 886.20001220703125, "invlev_up": 883.70001220703125, "invlev_dn": 883.70001220703125, "manhole_up": "manhole_187_generated", "manhole_dn": "manhole_188_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387402.432745414320379, 5855761.091833713464439 ], [ 1387355.687973388005048, 5855778.837216476909816 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1071", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 886.20001220703125, "elevtn_dn": 879.4000244140625, "invlev_up": 883.70001220703125, "invlev_dn": 876.9000244140625, "manhole_up": "manhole_188_generated", "manhole_dn": "manhole_189_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387355.687973388005048, 5855778.837216476909816 ], [ 1387308.943201361689717, 5855796.582599240355194 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1072", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 879.4000244140625, "elevtn_dn": 879.4000244140625, "invlev_up": 876.9000244140625, "invlev_dn": 876.9000244140625, "manhole_up": "manhole_189_generated", "manhole_dn": "manhole_190_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387308.943201361689717, 5855796.582599240355194 ], [ 1387262.861613623332232, 5855815.656713440082967 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1073", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 879.4000244140625, "elevtn_dn": 873.29998779296875, "invlev_up": 876.9000244140625, "invlev_dn": 870.79998779296875, "manhole_up": "manhole_190_generated", "manhole_dn": "manhole_191_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387262.861613623332232, 5855815.656713440082967 ], [ 1387224.059019178850576, 5855846.996291697025299 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1074", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 873.29998779296875, "elevtn_dn": 938.9000244140625, "invlev_up": 870.79998779296875, "invlev_dn": 936.4000244140625, "manhole_up": "manhole_191_generated", "manhole_dn": "manhole_192_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387224.059019178850576, 5855846.996291697025299 ], [ 1387180.719124856637791, 5855870.194651792757213 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1075", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 938.9000244140625, "elevtn_dn": 932.79998779296875, "invlev_up": 936.4000244140625, "invlev_dn": 930.29998779296875, "manhole_up": "manhole_192_generated", "manhole_dn": "manhole_193_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387180.719124856637791, 5855870.194651792757213 ], [ 1387131.003996425773948, 5855874.064550469629467 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1076", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 932.79998779296875, "elevtn_dn": 932.79998779296875, "invlev_up": 930.29998779296875, "invlev_dn": 930.29998779296875, "manhole_up": "manhole_193_generated", "manhole_dn": "manhole_194_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387131.003996425773948, 5855874.064550469629467 ], [ 1387081.098878284916282, 5855871.158613862469792 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1077", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 932.79998779296875, "elevtn_dn": 916.79998779296875, "invlev_up": 930.29998779296875, "invlev_dn": 914.29998779296875, "manhole_up": "manhole_194_generated", "manhole_dn": "manhole_195_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387081.098878284916282, 5855871.158613862469792 ], [ 1387031.198060098802671, 5855868.015261265449226 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1078", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 916.79998779296875, "elevtn_dn": 916.79998779296875, "invlev_up": 914.29998779296875, "invlev_dn": 914.29998779296875, "manhole_up": "manhole_195_generated", "manhole_dn": "manhole_196_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387031.198060098802671, 5855868.015261265449226 ], [ 1386981.297241912456229, 5855864.871908667497337 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1079", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 916.79998779296875, "elevtn_dn": 891.79998779296875, "invlev_up": 914.29998779296875, "invlev_dn": 889.29998779296875, "manhole_up": "manhole_196_generated", "manhole_dn": "manhole_197_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386981.297241912456229, 5855864.871908667497337 ], [ 1386931.47147326474078, 5855860.718019699677825 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1080", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 891.79998779296875, "elevtn_dn": 891.79998779296875, "invlev_up": 889.29998779296875, "invlev_dn": 889.29998779296875, "manhole_up": "manhole_197_generated", "manhole_dn": "manhole_198_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386931.47147326474078, 5855860.718019699677825 ], [ 1386881.600663758814335, 5855857.577047945931554 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1081", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 891.79998779296875, "elevtn_dn": 857.10003662109375, "invlev_up": 889.29998779296875, "invlev_dn": 854.60003662109375, "manhole_up": "manhole_198_generated", "manhole_dn": "manhole_199_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386881.600663758814335, 5855857.577047945931554 ], [ 1386832.545593914575875, 5855864.100992278195918 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1082", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 857.10003662109375, "elevtn_dn": 857.10003662109375, "invlev_up": 854.60003662109375, "invlev_dn": 854.60003662109375, "manhole_up": "manhole_199_generated", "manhole_dn": "manhole_200_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386832.545593914575875, 5855864.100992278195918 ], [ 1386787.06764860637486, 5855884.403254445642233 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1083", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 857.10003662109375, "elevtn_dn": 821.29998779296875, "invlev_up": 854.60003662109375, "invlev_dn": 818.79998779296875, "manhole_up": "manhole_200_generated", "manhole_dn": "manhole_201_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386787.06764860637486, 5855884.403254445642233 ], [ 1386748.278358669718727, 5855915.544586268253624 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1084", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 821.29998779296875, "elevtn_dn": 821.29998779296875, "invlev_up": 818.79998779296875, "invlev_dn": 818.79998779296875, "manhole_up": "manhole_201_generated", "manhole_dn": "manhole_202_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386748.278358669718727, 5855915.544586268253624 ], [ 1386721.155419877264649, 5855957.124278785660863 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1085", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 821.29998779296875, "elevtn_dn": 866.0, "invlev_up": 818.79998779296875, "invlev_dn": 863.5, "manhole_up": "manhole_202_generated", "manhole_dn": "manhole_203_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386721.155419877264649, 5855957.124278785660863 ], [ 1386707.750365849817172, 5856004.850832763127983 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1086", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 866.0, "invlev_up": 863.5, "invlev_dn": 863.5, "manhole_up": "manhole_203_generated", "manhole_dn": "manhole_204_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386707.750365849817172, 5856004.850832763127983 ], [ 1386699.832475832896307, 5856054.133603978902102 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1087", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 866.0, "invlev_up": 863.5, "invlev_dn": 863.5, "manhole_up": "manhole_204_generated", "manhole_dn": "manhole_205_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386699.832475832896307, 5856054.133603978902102 ], [ 1386697.095561265014112, 5856103.986880083568394 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1088", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 884.79998779296875, "invlev_up": 863.5, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_205_generated", "manhole_dn": "manhole_206_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386697.095561265014112, 5856103.986880083568394 ], [ 1386699.401158998254687, 5856153.933416903018951 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1089", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 884.79998779296875, "invlev_up": 882.29998779296875, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_206_generated", "manhole_dn": "manhole_207_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386699.401158998254687, 5856153.933416903018951 ], [ 1386715.699191288091242, 5856201.197657831013203 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1090", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 884.79998779296875, "invlev_up": 882.29998779296875, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_207_generated", "manhole_dn": "manhole_208_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386715.699191288091242, 5856201.197657831013203 ], [ 1386741.121203816728666, 5856244.100116757676005 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1091", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 915.9000244140625, "invlev_up": 882.29998779296875, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_208_generated", "manhole_dn": "manhole_209_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386741.121203816728666, 5856244.100116757676005 ], [ 1386774.051378605188802, 5856281.577651324681938 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1092", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_209_generated", "manhole_dn": "manhole_210_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386774.051378605188802, 5856281.577651324681938 ], [ 1386811.583791718119755, 5856314.587093180976808 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1093", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_210_generated", "manhole_dn": "manhole_211_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386811.583791718119755, 5856314.587093180976808 ], [ 1386839.378956499742344, 5856356.087350118905306 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1094", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_211_generated", "manhole_dn": "manhole_212_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386839.378956499742344, 5856356.087350118905306 ], [ 1386855.653891535941511, 5856403.364181768149137 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1095", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_212_generated", "manhole_dn": "manhole_213_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386855.653891535941511, 5856403.364181768149137 ], [ 1386875.714553950354457, 5856449.116945925168693 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1096", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_213_generated", "manhole_dn": "manhole_214_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386875.714553950354457, 5856449.116945925168693 ], [ 1386912.179653002182022, 5856482.939191372133791 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1097", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_214_generated", "manhole_dn": "manhole_215_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386912.179653002182022, 5856482.939191372133791 ], [ 1386944.191176384687424, 5856520.270725904032588 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1098", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 911.79998779296875, "invlev_up": 907.4000244140625, "invlev_dn": 909.29998779296875, "manhole_up": "manhole_215_generated", "manhole_dn": "manhole_216_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386944.191176384687424, 5856520.270725904032588 ], [ 1386964.188513180473819, 5856566.025075756013393 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1099", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 911.79998779296875, "elevtn_dn": 911.79998779296875, "invlev_up": 909.29998779296875, "invlev_dn": 909.29998779296875, "manhole_up": "manhole_216_generated", "manhole_dn": "manhole_217_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386964.188513180473819, 5856566.025075756013393 ], [ 1386998.825215350603685, 5856599.261941562406719 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1100", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 911.79998779296875, "elevtn_dn": 932.0, "invlev_up": 909.29998779296875, "invlev_dn": 929.5, "manhole_up": "manhole_217_generated", "manhole_dn": "manhole_218_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386998.825215350603685, 5856599.261941562406719 ], [ 1387044.828526843106374, 5856618.849377661012113 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1101", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 932.0, "invlev_up": 929.5, "invlev_dn": 929.5, "manhole_up": "manhole_218_generated", "manhole_dn": "manhole_219_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387044.828526843106374, 5856618.849377661012113 ], [ 1387090.831838335609064, 5856638.43681376054883 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1102", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 949.9000244140625, "invlev_up": 929.5, "invlev_dn": 947.4000244140625, "manhole_up": "manhole_219_generated", "manhole_dn": "manhole_220_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387090.831838335609064, 5856638.43681376054883 ], [ 1387136.835149827878922, 5856658.024249859154224 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1103", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 949.9000244140625, "elevtn_dn": 924.4000244140625, "invlev_up": 947.4000244140625, "invlev_dn": 921.9000244140625, "manhole_up": "manhole_220_generated", "manhole_dn": "manhole_221_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387136.835149827878922, 5856658.024249859154224 ], [ 1387178.671980312326923, 5856685.128790453076363 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1104", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 924.4000244140625, "elevtn_dn": 924.4000244140625, "invlev_up": 921.9000244140625, "invlev_dn": 921.9000244140625, "manhole_up": "manhole_221_generated", "manhole_dn": "manhole_222_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387178.671980312326923, 5856685.128790453076363 ], [ 1387217.700535611249506, 5856716.320352808572352 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1105", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 924.4000244140625, "elevtn_dn": 940.0, "invlev_up": 921.9000244140625, "invlev_dn": 937.5, "manhole_up": "manhole_222_generated", "manhole_dn": "manhole_223_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387217.700535611249506, 5856716.320352808572352 ], [ 1387252.016686553368345, 5856752.649443434551358 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1106", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 940.0, "elevtn_dn": 940.0, "invlev_up": 937.5, "invlev_dn": 937.5, "manhole_up": "manhole_223_generated", "manhole_dn": "manhole_224_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387252.016686553368345, 5856752.649443434551358 ], [ 1387284.798919493798167, 5856790.190159549936652 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1107", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 940.0, "elevtn_dn": 894.29998779296875, "invlev_up": 937.5, "invlev_dn": 891.79998779296875, "manhole_up": "manhole_224_generated", "manhole_dn": "manhole_225_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387284.798919493798167, 5856790.190159549936652 ], [ 1387273.050185391213745, 5856831.931571422144771 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1108", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 894.29998779296875, "elevtn_dn": 891.5, "invlev_up": 891.79998779296875, "invlev_dn": 889.0, "manhole_up": "manhole_225_generated", "manhole_dn": "manhole_226_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387273.050185391213745, 5856831.931571422144771 ], [ 1387226.106990416301414, 5856849.145192969590425 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1109", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 891.5, "elevtn_dn": 891.5, "invlev_up": 889.0, "invlev_dn": 889.0, "manhole_up": "manhole_226_generated", "manhole_dn": "manhole_227_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387226.106990416301414, 5856849.145192969590425 ], [ 1387179.163795441389084, 5856866.358814516104758 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1110", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 891.5, "elevtn_dn": 881.0, "invlev_up": 889.0, "invlev_dn": 878.5, "manhole_up": "manhole_227_generated", "manhole_dn": "manhole_228_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387179.163795441389084, 5856866.358814516104758 ], [ 1387132.220600466709584, 5856883.572436063550413 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1111", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_228_generated", "manhole_dn": "manhole_229_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387132.220600466709584, 5856883.572436063550413 ], [ 1387091.513159692520276, 5856911.129930667579174 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1112", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_229_generated", "manhole_dn": "manhole_230_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387091.513159692520276, 5856911.129930667579174 ], [ 1387071.007118243258446, 5856956.15559543017298 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1113", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_230_generated", "manhole_dn": "manhole_231_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387071.007118243258446, 5856956.15559543017298 ], [ 1387043.749112035380676, 5856996.689189162105322 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1114", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 856.5, "invlev_up": 878.5, "invlev_dn": 854.0, "manhole_up": "manhole_231_generated", "manhole_dn": "manhole_232_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387043.749112035380676, 5856996.689189162105322 ], [ 1387004.639443967491388, 5857027.840532388538122 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1115", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_232_generated", "manhole_dn": "manhole_233_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387004.639443967491388, 5857027.840532388538122 ], [ 1386965.529775899834931, 5857058.991875615902245 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1116", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_233_generated", "manhole_dn": "manhole_234_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386965.529775899834931, 5857058.991875615902245 ], [ 1386926.702535050921142, 5857090.440239730291069 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1117", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_234_generated", "manhole_dn": "manhole_235_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386926.702535050921142, 5857090.440239730291069 ], [ 1386899.700979894958436, 5857131.871505072340369 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1118", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_235_generated", "manhole_dn": "manhole_236_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386899.700979894958436, 5857131.871505072340369 ], [ 1386903.6263940166682, 5857181.005935152061284 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1119", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 867.29998779296875, "invlev_up": 854.0, "invlev_dn": 864.79998779296875, "manhole_up": "manhole_236_generated", "manhole_dn": "manhole_237_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386903.6263940166682, 5857181.005935152061284 ], [ 1386920.841401966754347, 5857227.85734468139708 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1120", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 867.29998779296875, "elevtn_dn": 867.29998779296875, "invlev_up": 864.79998779296875, "invlev_dn": 864.79998779296875, "manhole_up": "manhole_237_generated", "manhole_dn": "manhole_238_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386920.841401966754347, 5857227.85734468139708 ], [ 1386940.647245415020734, 5857273.767048302106559 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1121", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 867.29998779296875, "elevtn_dn": 879.0, "invlev_up": 864.79998779296875, "invlev_dn": 876.5, "manhole_up": "manhole_238_generated", "manhole_dn": "manhole_239_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386940.647245415020734, 5857273.767048302106559 ], [ 1386960.453088863519952, 5857319.676751921884716 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1122", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 879.0, "elevtn_dn": 884.5, "invlev_up": 876.5, "invlev_dn": 882.0, "manhole_up": "manhole_239_generated", "manhole_dn": "manhole_240_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386960.453088863519952, 5857319.676751921884716 ], [ 1386980.258932311786339, 5857365.586455542594194 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1123", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 884.5, "invlev_up": 882.0, "invlev_dn": 882.0, "manhole_up": "manhole_240_generated", "manhole_dn": "manhole_241_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386980.258932311786339, 5857365.586455542594194 ], [ 1387000.064775760285556, 5857411.496159162372351 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1124", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 884.5, "invlev_up": 882.0, "invlev_dn": 882.0, "manhole_up": "manhole_241_generated", "manhole_dn": "manhole_242_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387000.064775760285556, 5857411.496159162372351 ], [ 1387007.528902114601806, 5857459.537025099620223 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1125", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 893.20001220703125, "invlev_up": 882.0, "invlev_dn": 890.70001220703125, "manhole_up": "manhole_242_generated", "manhole_dn": "manhole_243_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387007.528902114601806, 5857459.537025099620223 ], [ 1386963.21676475298591, 5857476.629049208015203 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1126", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 893.20001220703125, "elevtn_dn": 893.70001220703125, "invlev_up": 890.70001220703125, "invlev_dn": 891.20001220703125, "manhole_up": "manhole_243_generated", "manhole_dn": "manhole_244_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386963.21676475298591, 5857476.629049208015203 ], [ 1386913.783934087026864, 5857484.135433598421514 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1127", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 893.70001220703125, "elevtn_dn": 893.70001220703125, "invlev_up": 891.20001220703125, "invlev_dn": 891.20001220703125, "manhole_up": "manhole_244_generated", "manhole_dn": "manhole_245_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386913.783934087026864, 5857484.135433598421514 ], [ 1386870.539328352315351, 5857507.055611960589886 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1128", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 893.70001220703125, "elevtn_dn": 889.70001220703125, "invlev_up": 891.20001220703125, "invlev_dn": 887.20001220703125, "manhole_up": "manhole_245_generated", "manhole_dn": "manhole_246_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386870.539328352315351, 5857507.055611960589886 ], [ 1386832.820274166297168, 5857539.877026806585491 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1129", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 889.70001220703125, "elevtn_dn": 889.70001220703125, "invlev_up": 887.20001220703125, "invlev_dn": 887.20001220703125, "manhole_up": "manhole_246_generated", "manhole_dn": "manhole_247_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386832.820274166297168, 5857539.877026806585491 ], [ 1386795.101531907683238, 5857572.698800123296678 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1130", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 889.70001220703125, "elevtn_dn": 872.4000244140625, "invlev_up": 887.20001220703125, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_247_generated", "manhole_dn": "manhole_248_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386795.101531907683238, 5857572.698800123296678 ], [ 1386758.257366374600679, 5857606.496797049418092 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1131", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 872.4000244140625, "invlev_up": 869.9000244140625, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_248_generated", "manhole_dn": "manhole_249_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386758.257366374600679, 5857606.496797049418092 ], [ 1386721.502390186069533, 5857640.394349270500243 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1132", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 872.4000244140625, "invlev_up": 869.9000244140625, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_249_generated", "manhole_dn": "manhole_250_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386721.502390186069533, 5857640.394349270500243 ], [ 1386691.639095245627686, 5857680.292891399934888 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1133", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 860.70001220703125, "invlev_up": 869.9000244140625, "invlev_dn": 858.20001220703125, "manhole_up": "manhole_250_generated", "manhole_dn": "manhole_251_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386691.639095245627686, 5857680.292891399934888 ], [ 1386663.127201205352321, 5857721.366519738920033 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1134", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 860.70001220703125, "elevtn_dn": 864.10003662109375, "invlev_up": 858.20001220703125, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_251_generated", "manhole_dn": "manhole_252_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386663.127201205352321, 5857721.366519738920033 ], [ 1386634.70784462057054, 5857762.504245642572641 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1135", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 864.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_252_generated", "manhole_dn": "manhole_253_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386634.70784462057054, 5857762.504245642572641 ], [ 1386606.28848803602159, 5857803.64197154622525 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1136", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 864.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_253_generated", "manhole_dn": "manhole_254_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386606.28848803602159, 5857803.64197154622525 ], [ 1386577.851668093586341, 5857844.766917760483921 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1137", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 836.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 833.60003662109375, "manhole_up": "manhole_254_generated", "manhole_dn": "manhole_255_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386577.851668093586341, 5857844.766917760483921 ], [ 1386559.479123871540651, 5857890.340473555959761 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1138", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 836.10003662109375, "elevtn_dn": 836.10003662109375, "invlev_up": 833.60003662109375, "invlev_dn": 833.60003662109375, "manhole_up": "manhole_255_generated", "manhole_dn": "manhole_256_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386559.479123871540651, 5857890.340473555959761 ], [ 1386576.858566463226452, 5857935.633445805869997 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1139", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 836.10003662109375, "elevtn_dn": 854.9000244140625, "invlev_up": 833.60003662109375, "invlev_dn": 852.4000244140625, "manhole_up": "manhole_256_generated", "manhole_dn": "manhole_257_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386576.858566463226452, 5857935.633445805869997 ], [ 1386619.073707325849682, 5857961.189545376226306 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1140", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 854.9000244140625, "elevtn_dn": 854.9000244140625, "invlev_up": 852.4000244140625, "invlev_dn": 852.4000244140625, "manhole_up": "manhole_257_generated", "manhole_dn": "manhole_258_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386619.073707325849682, 5857961.189545376226306 ], [ 1386664.860782509436831, 5857981.27706332411617 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1141", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 854.9000244140625, "elevtn_dn": 871.60003662109375, "invlev_up": 852.4000244140625, "invlev_dn": 869.10003662109375, "manhole_up": "manhole_258_generated", "manhole_dn": "manhole_259_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386664.860782509436831, 5857981.27706332411617 ], [ 1386710.721602912992239, 5858001.195835201069713 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1142", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 871.60003662109375, "elevtn_dn": 865.10003662109375, "invlev_up": 869.10003662109375, "invlev_dn": 862.60003662109375, "manhole_up": "manhole_259_generated", "manhole_dn": "manhole_260_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386710.721602912992239, 5858001.195835201069713 ], [ 1386756.582423316547647, 5858021.114607078954577 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1143", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 865.10003662109375, "elevtn_dn": 864.70001220703125, "invlev_up": 862.60003662109375, "invlev_dn": 862.20001220703125, "manhole_up": "manhole_260_generated", "manhole_dn": "manhole_261_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386756.582423316547647, 5858021.114607078954577 ], [ 1386802.443243720103055, 5858041.033378956839442 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1144", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 864.70001220703125, "elevtn_dn": 864.70001220703125, "invlev_up": 862.20001220703125, "invlev_dn": 862.20001220703125, "manhole_up": "manhole_261_generated", "manhole_dn": "manhole_262_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386802.443243720103055, 5858041.033378956839442 ], [ 1386848.304064123658463, 5858060.952150834724307 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1145", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 864.70001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 862.20001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_262_generated", "manhole_dn": "manhole_263_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386848.304064123658463, 5858060.952150834724307 ], [ 1386892.843548113014549, 5858083.471454747952521 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1146", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_263_generated", "manhole_dn": "manhole_264_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386892.843548113014549, 5858083.471454747952521 ], [ 1386931.443847785238177, 5858115.251781782135367 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1147", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 853.60003662109375, "invlev_up": 856.70001220703125, "invlev_dn": 851.10003662109375, "manhole_up": "manhole_264_generated", "manhole_dn": "manhole_265_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386931.443847785238177, 5858115.251781782135367 ], [ 1386970.044147457228974, 5858147.032108817249537 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1148", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 853.60003662109375, "elevtn_dn": 853.60003662109375, "invlev_up": 851.10003662109375, "invlev_dn": 851.10003662109375, "manhole_up": "manhole_265_generated", "manhole_dn": "manhole_266_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386970.044147457228974, 5858147.032108817249537 ], [ 1387008.644447129452601, 5858178.812435851432383 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1149", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 853.60003662109375, "elevtn_dn": 842.4000244140625, "invlev_up": 851.10003662109375, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_266_generated", "manhole_dn": "manhole_267_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387008.644447129452601, 5858178.812435851432383 ], [ 1387047.244746801443398, 5858210.592762886546552 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1150", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 842.4000244140625, "invlev_up": 839.9000244140625, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_267_generated", "manhole_dn": "manhole_268_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387047.244746801443398, 5858210.592762886546552 ], [ 1387085.845046473667026, 5858242.373089920729399 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1151", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 842.4000244140625, "invlev_up": 839.9000244140625, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_268_generated", "manhole_dn": "manhole_269_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387085.845046473667026, 5858242.373089920729399 ], [ 1387124.445346145657822, 5858274.153416955843568 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1152", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 827.60003662109375, "invlev_up": 839.9000244140625, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_269_generated", "manhole_dn": "manhole_270_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387124.445346145657822, 5858274.153416955843568 ], [ 1387163.04564581788145, 5858305.933743990026414 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1153", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_270_generated", "manhole_dn": "manhole_271_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387163.04564581788145, 5858305.933743990026414 ], [ 1387201.829349192325026, 5858337.489215047098696 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1154", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 837.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 835.10003662109375, "manhole_up": "manhole_271_generated", "manhole_dn": "manhole_272_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387201.829349192325026, 5858337.489215047098696 ], [ 1387246.200623227981851, 5858359.687651782296598 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1155", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 837.60003662109375, "elevtn_dn": 837.60003662109375, "invlev_up": 835.10003662109375, "invlev_dn": 835.10003662109375, "manhole_up": "manhole_272_generated", "manhole_dn": "manhole_273_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387246.200623227981851, 5858359.687651782296598 ], [ 1387293.201938283629715, 5858376.741938757710159 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1156", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 837.60003662109375, "elevtn_dn": 843.79998779296875, "invlev_up": 835.10003662109375, "invlev_dn": 841.29998779296875, "manhole_up": "manhole_273_generated", "manhole_dn": "manhole_274_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387293.201938283629715, 5858376.741938757710159 ], [ 1387334.200528149493039, 5858401.732468435540795 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1157", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 843.79998779296875, "elevtn_dn": 822.60003662109375, "invlev_up": 841.29998779296875, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_274_generated", "manhole_dn": "manhole_275_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387334.200528149493039, 5858401.732468435540795 ], [ 1387307.843875054037198, 5858437.110805934295058 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1158", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 822.60003662109375, "invlev_up": 820.10003662109375, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_275_generated", "manhole_dn": "manhole_276_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387307.843875054037198, 5858437.110805934295058 ], [ 1387260.279569417703897, 5858425.045736069791019 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1159", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 820.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_276_generated", "manhole_dn": "manhole_277_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387260.279569417703897, 5858425.045736069791019 ], [ 1387211.448235018178821, 5858414.300554806366563 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1160", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_277_generated", "manhole_dn": "manhole_278_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387211.448235018178821, 5858414.300554806366563 ], [ 1387162.612191663123667, 5858403.576134512200952 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1161", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 822.29998779296875, "invlev_up": 825.10003662109375, "invlev_dn": 819.79998779296875, "manhole_up": "manhole_278_generated", "manhole_dn": "manhole_279_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387162.612191663123667, 5858403.576134512200952 ], [ 1387113.700150535441935, 5858393.210482948459685 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1162", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 822.29998779296875, "elevtn_dn": 822.29998779296875, "invlev_up": 819.79998779296875, "invlev_dn": 819.79998779296875, "manhole_up": "manhole_279_generated", "manhole_dn": "manhole_280_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387113.700150535441935, 5858393.210482948459685 ], [ 1387064.993171223672107, 5858381.975642333738506 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1163", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 822.29998779296875, "elevtn_dn": 827.79998779296875, "invlev_up": 819.79998779296875, "invlev_dn": 825.29998779296875, "manhole_up": "manhole_280_generated", "manhole_dn": "manhole_281_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387064.993171223672107, 5858381.975642333738506 ], [ 1387015.796386598376557, 5858376.342007979750633 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1164", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.79998779296875, "elevtn_dn": 827.79998779296875, "invlev_up": 825.29998779296875, "invlev_dn": 825.29998779296875, "manhole_up": "manhole_281_generated", "manhole_dn": "manhole_282_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387015.796386598376557, 5858376.342007979750633 ], [ 1386966.208506174152717, 5858382.746259398758411 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1165", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.79998779296875, "elevtn_dn": 833.9000244140625, "invlev_up": 825.29998779296875, "invlev_dn": 831.4000244140625, "manhole_up": "manhole_282_generated", "manhole_dn": "manhole_283_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386966.208506174152717, 5858382.746259398758411 ], [ 1386916.676812386140227, 5858389.559525708667934 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1166", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 833.9000244140625, "elevtn_dn": 833.9000244140625, "invlev_up": 831.4000244140625, "invlev_dn": 831.4000244140625, "manhole_up": "manhole_283_generated", "manhole_dn": "manhole_284_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386916.676812386140227, 5858389.559525708667934 ], [ 1386867.198860567295924, 5858396.764010772109032 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1167", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 833.9000244140625, "elevtn_dn": 833.20001220703125, "invlev_up": 831.4000244140625, "invlev_dn": 830.70001220703125, "manhole_up": "manhole_284_generated", "manhole_dn": "manhole_285_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386867.198860567295924, 5858396.764010772109032 ], [ 1386820.816385147860274, 5858411.854353901930153 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1168", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 833.20001220703125, "elevtn_dn": 809.60003662109375, "invlev_up": 830.70001220703125, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_285_generated", "manhole_dn": "manhole_286_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386820.816385147860274, 5858411.854353901930153 ], [ 1386841.361234750133008, 5858445.514383808709681 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1169", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 809.79998779296875, "invlev_up": 807.10003662109375, "invlev_dn": 807.29998779296875, "manhole_up": "manhole_286_generated", "manhole_dn": "manhole_287_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386841.361234750133008, 5858445.514383808709681 ], [ 1386890.796275103231892, 5858452.915634987875819 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1170", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.79998779296875, "elevtn_dn": 809.79998779296875, "invlev_up": 807.29998779296875, "invlev_dn": 807.29998779296875, "manhole_up": "manhole_287_generated", "manhole_dn": "manhole_288_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386890.796275103231892, 5858452.915634987875819 ], [ 1386940.277140651131049, 5858460.100081093609333 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1171", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.79998779296875, "elevtn_dn": 805.4000244140625, "invlev_up": 807.29998779296875, "invlev_dn": 802.9000244140625, "manhole_up": "manhole_288_generated", "manhole_dn": "manhole_289_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386940.277140651131049, 5858460.100081093609333 ], [ 1386989.847997799050063, 5858466.483407464809716 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1172", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.4000244140625, "elevtn_dn": 805.4000244140625, "invlev_up": 802.9000244140625, "invlev_dn": 802.9000244140625, "manhole_up": "manhole_289_generated", "manhole_dn": "manhole_290_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386989.847997799050063, 5858466.483407464809716 ], [ 1387039.689648573985323, 5858470.45608530472964 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1173", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.4000244140625, "elevtn_dn": 804.60003662109375, "invlev_up": 802.9000244140625, "invlev_dn": 802.10003662109375, "manhole_up": "manhole_290_generated", "manhole_dn": "manhole_291_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387039.689648573985323, 5858470.45608530472964 ], [ 1387088.843806148739532, 5858479.424946941435337 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1174", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.60003662109375, "elevtn_dn": 809.9000244140625, "invlev_up": 802.10003662109375, "invlev_dn": 807.4000244140625, "manhole_up": "manhole_291_generated", "manhole_dn": "manhole_292_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387088.843806148739532, 5858479.424946941435337 ], [ 1387137.90604472765699, 5858489.061806742101908 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1175", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.9000244140625, "elevtn_dn": 809.9000244140625, "invlev_up": 807.4000244140625, "invlev_dn": 807.4000244140625, "manhole_up": "manhole_292_generated", "manhole_dn": "manhole_293_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387137.90604472765699, 5858489.061806742101908 ], [ 1387186.336529975291342, 5858500.87968063633889 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1176", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.9000244140625, "elevtn_dn": 822.60003662109375, "invlev_up": 807.4000244140625, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_293_generated", "manhole_dn": "manhole_294_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387186.336529975291342, 5858500.87968063633889 ], [ 1387231.661050535272807, 5858521.423059928230941 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1177", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 787.70001220703125, "invlev_up": 820.10003662109375, "invlev_dn": 785.20001220703125, "manhole_up": "manhole_294_generated", "manhole_dn": "manhole_295_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387231.661050535272807, 5858521.423059928230941 ], [ 1387268.120024613803253, 5858555.03504909388721 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1178", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 787.70001220703125, "elevtn_dn": 787.70001220703125, "invlev_up": 785.20001220703125, "invlev_dn": 785.20001220703125, "manhole_up": "manhole_295_generated", "manhole_dn": "manhole_296_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387268.120024613803253, 5858555.03504909388721 ], [ 1387300.917169471969828, 5858592.775208213366568 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1179", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 787.70001220703125, "elevtn_dn": 797.10003662109375, "invlev_up": 785.20001220703125, "invlev_dn": 794.60003662109375, "manhole_up": "manhole_296_generated", "manhole_dn": "manhole_297_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387300.917169471969828, 5858592.775208213366568 ], [ 1387340.521646688459441, 5858622.315198052674532 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1180", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 797.10003662109375, "elevtn_dn": 797.10003662109375, "invlev_up": 794.60003662109375, "invlev_dn": 794.60003662109375, "manhole_up": "manhole_297_generated", "manhole_dn": "manhole_298_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387340.521646688459441, 5858622.315198052674532 ], [ 1387387.476920192595571, 5858639.495844470337033 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1181", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 797.10003662109375, "elevtn_dn": 806.10003662109375, "invlev_up": 794.60003662109375, "invlev_dn": 803.60003662109375, "manhole_up": "manhole_298_generated", "manhole_dn": "manhole_299_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387387.476920192595571, 5858639.495844470337033 ], [ 1387436.116963447071612, 5858650.82861250359565 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1182", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.10003662109375, "elevtn_dn": 806.10003662109375, "invlev_up": 803.60003662109375, "invlev_dn": 803.60003662109375, "manhole_up": "manhole_299_generated", "manhole_dn": "manhole_300_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387436.116963447071612, 5858650.82861250359565 ], [ 1387485.194103535497561, 5858660.261457678861916 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1183", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.10003662109375, "elevtn_dn": 807.70001220703125, "invlev_up": 803.60003662109375, "invlev_dn": 805.20001220703125, "manhole_up": "manhole_300_generated", "manhole_dn": "manhole_301_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387485.194103535497561, 5858660.261457678861916 ], [ 1387533.804190448950976, 5858671.493853995576501 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1184", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.70001220703125, "elevtn_dn": 772.20001220703125, "invlev_up": 805.20001220703125, "invlev_dn": 769.70001220703125, "manhole_up": "manhole_301_generated", "manhole_dn": "manhole_302_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387533.804190448950976, 5858671.493853995576501 ], [ 1387580.2968336828053, 5858689.619015210308135 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1185", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.20001220703125, "elevtn_dn": 778.79998779296875, "invlev_up": 769.70001220703125, "invlev_dn": 776.29998779296875, "manhole_up": "manhole_302_generated", "manhole_dn": "manhole_303_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387580.2968336828053, 5858689.619015210308135 ], [ 1387628.455277157016098, 5858703.062848121859133 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1186", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.79998779296875, "elevtn_dn": 778.79998779296875, "invlev_up": 776.29998779296875, "invlev_dn": 776.29998779296875, "manhole_up": "manhole_303_generated", "manhole_dn": "manhole_304_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387628.455277157016098, 5858703.062848121859133 ], [ 1387677.211432087467983, 5858713.7862489502877 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1187", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.79998779296875, "elevtn_dn": 786.70001220703125, "invlev_up": 776.29998779296875, "invlev_dn": 784.20001220703125, "manhole_up": "manhole_304_generated", "manhole_dn": "manhole_305_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387677.211432087467983, 5858713.7862489502877 ], [ 1387726.995392211945727, 5858712.747126803733408 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1188", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.70001220703125, "elevtn_dn": 786.70001220703125, "invlev_up": 784.20001220703125, "invlev_dn": 784.20001220703125, "manhole_up": "manhole_305_generated", "manhole_dn": "manhole_306_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387726.995392211945727, 5858712.747126803733408 ], [ 1387773.343349169706926, 5858725.014477553777397 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1189", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.70001220703125, "elevtn_dn": 797.70001220703125, "invlev_up": 784.20001220703125, "invlev_dn": 795.20001220703125, "manhole_up": "manhole_306_generated", "manhole_dn": "manhole_307_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387773.343349169706926, 5858725.014477553777397 ], [ 1387806.363672176143155, 5858762.310494473204017 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1190", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 797.70001220703125, "elevtn_dn": 797.70001220703125, "invlev_up": 795.20001220703125, "invlev_dn": 795.20001220703125, "manhole_up": "manhole_307_generated", "manhole_dn": "manhole_308_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387806.363672176143155, 5858762.310494473204017 ], [ 1387799.717027904232964, 5858810.149600365199149 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1191", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 797.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 795.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_308_generated", "manhole_dn": "manhole_309_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387799.717027904232964, 5858810.149600365199149 ], [ 1387771.971139753237367, 5858850.86109375115484 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1192", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_309_generated", "manhole_dn": "manhole_310_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387771.971139753237367, 5858850.86109375115484 ], [ 1387723.07675126590766, 5858854.679317841306329 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1193", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_310_generated", "manhole_dn": "manhole_311_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387723.07675126590766, 5858854.679317841306329 ], [ 1387673.274138238513842, 5858850.996178055182099 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1194", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_311_generated", "manhole_dn": "manhole_312_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387673.274138238513842, 5858850.996178055182099 ], [ 1387624.170362570788711, 5858858.384703231044114 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1195", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_312_generated", "manhole_dn": "manhole_313_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387624.170362570788711, 5858858.384703231044114 ], [ 1387575.715393897145987, 5858857.046076283790171 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1196", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_313_generated", "manhole_dn": "manhole_314_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387575.715393897145987, 5858857.046076283790171 ], [ 1387529.438332577701658, 5858838.116818149574101 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1197", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_314_generated", "manhole_dn": "manhole_315_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387529.438332577701658, 5858838.116818149574101 ], [ 1387481.179235466290265, 5858825.222027675248682 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1198", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_315_generated", "manhole_dn": "manhole_316_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387481.179235466290265, 5858825.222027675248682 ], [ 1387432.215501294471323, 5858815.797906777821481 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1199", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 772.79998779296875, "invlev_up": 774.70001220703125, "invlev_dn": 770.29998779296875, "manhole_up": "manhole_316_generated", "manhole_dn": "manhole_317_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387432.215501294471323, 5858815.797906777821481 ], [ 1387382.431881646160036, 5858811.154251328669488 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1200", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.79998779296875, "elevtn_dn": 747.10003662109375, "invlev_up": 770.29998779296875, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_317_generated", "manhole_dn": "manhole_318_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387382.431881646160036, 5858811.154251328669488 ], [ 1387336.607072548242286, 5858824.075685098767281 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1201", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 747.10003662109375, "invlev_up": 744.60003662109375, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_318_generated", "manhole_dn": "manhole_319_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387336.607072548242286, 5858824.075685098767281 ], [ 1387327.458137275883928, 5858870.88596049696207 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1202", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 747.10003662109375, "invlev_up": 744.60003662109375, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_319_generated", "manhole_dn": "manhole_320_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387327.458137275883928, 5858870.88596049696207 ], [ 1387344.619252334116027, 5858917.848375800997019 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1203", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 773.70001220703125, "invlev_up": 744.60003662109375, "invlev_dn": 771.20001220703125, "manhole_up": "manhole_320_generated", "manhole_dn": "manhole_321_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387344.619252334116027, 5858917.848375800997019 ], [ 1387358.089983508689329, 5858965.710649829357862 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1204", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 773.70001220703125, "elevtn_dn": 773.70001220703125, "invlev_up": 771.20001220703125, "invlev_dn": 771.20001220703125, "manhole_up": "manhole_321_generated", "manhole_dn": "manhole_322_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387358.089983508689329, 5858965.710649829357862 ], [ 1387329.564612702699378, 5859003.583583393134177 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1205", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 773.70001220703125, "elevtn_dn": 774.29998779296875, "invlev_up": 771.20001220703125, "invlev_dn": 771.79998779296875, "manhole_up": "manhole_322_generated", "manhole_dn": "manhole_323_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387329.564612702699378, 5859003.583583393134177 ], [ 1387285.783744251355529, 5858993.703191691078246 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1206", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 774.29998779296875, "elevtn_dn": 774.29998779296875, "invlev_up": 771.79998779296875, "invlev_dn": 771.79998779296875, "manhole_up": "manhole_323_generated", "manhole_dn": "manhole_324_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387285.783744251355529, 5858993.703191691078246 ], [ 1387248.355973182013258, 5858961.31797497626394 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1207", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 774.29998779296875, "elevtn_dn": 769.4000244140625, "invlev_up": 771.79998779296875, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_324_generated", "manhole_dn": "manhole_325_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387248.355973182013258, 5858961.31797497626394 ], [ 1387199.500433639157563, 5858963.645901591517031 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1208", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 769.4000244140625, "invlev_up": 766.9000244140625, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_325_generated", "manhole_dn": "manhole_326_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387199.500433639157563, 5858963.645901591517031 ], [ 1387151.482699199579656, 5858977.583961015567183 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1209", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 762.60003662109375, "invlev_up": 766.9000244140625, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_326_generated", "manhole_dn": "manhole_327_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387151.482699199579656, 5858977.583961015567183 ], [ 1387103.632611613254994, 5858992.082134889438748 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1210", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 762.60003662109375, "invlev_up": 760.10003662109375, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_327_generated", "manhole_dn": "manhole_328_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387103.632611613254994, 5858992.082134889438748 ], [ 1387055.853339510038495, 5859006.816905959509313 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1211", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 755.79998779296875, "invlev_up": 760.10003662109375, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_328_generated", "manhole_dn": "manhole_329_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387055.853339510038495, 5859006.816905959509313 ], [ 1387008.074067406589165, 5859021.551677029579878 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1212", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_329_generated", "manhole_dn": "manhole_330_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387008.074067406589165, 5859021.551677029579878 ], [ 1386960.294795303372666, 5859036.286448099650443 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1213", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 749.5, "invlev_up": 753.29998779296875, "invlev_dn": 747.0, "manhole_up": "manhole_330_generated", "manhole_dn": "manhole_331_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386960.294795303372666, 5859036.286448099650443 ], [ 1386912.515523200156167, 5859051.021219169721007 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1214", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 749.5, "elevtn_dn": 749.5, "invlev_up": 747.0, "invlev_dn": 747.0, "manhole_up": "manhole_331_generated", "manhole_dn": "manhole_332_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386912.515523200156167, 5859051.021219169721007 ], [ 1386864.736251096706837, 5859065.755990239791572 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1215", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 749.5, "elevtn_dn": 727.10003662109375, "invlev_up": 747.0, "invlev_dn": 724.60003662109375, "manhole_up": "manhole_332_generated", "manhole_dn": "manhole_333_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386864.736251096706837, 5859065.755990239791572 ], [ 1386816.956978993490338, 5859080.490761309862137 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1216", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 727.10003662109375, "elevtn_dn": 752.29998779296875, "invlev_up": 724.60003662109375, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_333_generated", "manhole_dn": "manhole_334_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386816.956978993490338, 5859080.490761309862137 ], [ 1386769.832018451532349, 5859096.976014334708452 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1217", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 738.0, "invlev_up": 749.79998779296875, "invlev_dn": 735.5, "manhole_up": "manhole_334_generated", "manhole_dn": "manhole_335_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386769.832018451532349, 5859096.976014334708452 ], [ 1386724.102282747160643, 5859117.193917133845389 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1218", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 738.0, "invlev_up": 735.5, "invlev_dn": 735.5, "manhole_up": "manhole_335_generated", "manhole_dn": "manhole_336_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386724.102282747160643, 5859117.193917133845389 ], [ 1386678.372547042788938, 5859137.411819933913648 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1219", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 732.79998779296875, "invlev_up": 735.5, "invlev_dn": 730.29998779296875, "manhole_up": "manhole_336_generated", "manhole_dn": "manhole_337_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386678.372547042788938, 5859137.411819933913648 ], [ 1386632.642811338417232, 5859157.629722733050585 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1220", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.79998779296875, "elevtn_dn": 732.79998779296875, "invlev_up": 730.29998779296875, "invlev_dn": 730.29998779296875, "manhole_up": "manhole_337_generated", "manhole_dn": "manhole_338_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386632.642811338417232, 5859157.629722733050585 ], [ 1386586.913075634045526, 5859177.847625533118844 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1221", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.79998779296875, "elevtn_dn": 732.60003662109375, "invlev_up": 730.29998779296875, "invlev_dn": 730.10003662109375, "manhole_up": "manhole_338_generated", "manhole_dn": "manhole_339_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386586.913075634045526, 5859177.847625533118844 ], [ 1386541.181931287748739, 5859198.062337793409824 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1222", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.60003662109375, "elevtn_dn": 732.60003662109375, "invlev_up": 730.10003662109375, "invlev_dn": 730.10003662109375, "manhole_up": "manhole_339_generated", "manhole_dn": "manhole_340_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386541.181931287748739, 5859198.062337793409824 ], [ 1386495.431538854492828, 5859218.233453613705933 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1223", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.60003662109375, "elevtn_dn": 742.5, "invlev_up": 730.10003662109375, "invlev_dn": 740.0, "manhole_up": "manhole_340_generated", "manhole_dn": "manhole_341_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386495.431538854492828, 5859218.233453613705933 ], [ 1386449.681146421469748, 5859238.404569433070719 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1224", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 742.5, "invlev_up": 740.0, "invlev_dn": 740.0, "manhole_up": "manhole_341_generated", "manhole_dn": "manhole_342_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386449.681146421469748, 5859238.404569433070719 ], [ 1386404.749107032548636, 5859260.314221715554595 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1225", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 717.60003662109375, "invlev_up": 740.0, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_342_generated", "manhole_dn": "manhole_343_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386404.749107032548636, 5859260.314221715554595 ], [ 1386360.756595908896998, 5859284.020064728334546 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1226", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 717.60003662109375, "invlev_up": 715.10003662109375, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_343_generated", "manhole_dn": "manhole_344_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386360.756595908896998, 5859284.020064728334546 ], [ 1386317.622744857333601, 5859309.307279178872705 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1227", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 711.0, "invlev_up": 715.10003662109375, "invlev_dn": 708.5, "manhole_up": "manhole_344_generated", "manhole_dn": "manhole_345_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386317.622744857333601, 5859309.307279178872705 ], [ 1386274.488893805770203, 5859334.594493629410863 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1228", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 711.0, "elevtn_dn": 717.60003662109375, "invlev_up": 708.5, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_345_generated", "manhole_dn": "manhole_346_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386274.488893805770203, 5859334.594493629410863 ], [ 1386231.354723542230204, 5859359.881163572892547 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1229", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 739.0, "invlev_up": 715.10003662109375, "invlev_dn": 736.5, "manhole_up": "manhole_346_generated", "manhole_dn": "manhole_347_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386231.354723542230204, 5859359.881163572892547 ], [ 1386188.788941488368437, 5859385.978958465158939 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1230", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 739.0, "invlev_up": 736.5, "invlev_dn": 736.5, "manhole_up": "manhole_347_generated", "manhole_dn": "manhole_348_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386188.788941488368437, 5859385.978958465158939 ], [ 1386153.170269979629666, 5859420.751348914578557 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1231", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 739.0, "invlev_up": 736.5, "invlev_dn": 736.5, "manhole_up": "manhole_348_generated", "manhole_dn": "manhole_349_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386153.170269979629666, 5859420.751348914578557 ], [ 1386127.241226618411019, 5859463.08446778729558 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1232", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 770.60003662109375, "invlev_up": 736.5, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_349_generated", "manhole_dn": "manhole_350_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386127.241226618411019, 5859463.08446778729558 ], [ 1386108.996456971857697, 5859509.052053713239729 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1233", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_350_generated", "manhole_dn": "manhole_351_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386108.996456971857697, 5859509.052053713239729 ], [ 1386105.954033384332433, 5859558.959127158857882 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1234", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_351_generated", "manhole_dn": "manhole_352_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386105.954033384332433, 5859558.959127158857882 ], [ 1386101.917093347059563, 5859608.782215913757682 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1235", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 779.79998779296875, "invlev_up": 768.10003662109375, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_352_generated", "manhole_dn": "manhole_353_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386101.917093347059563, 5859608.782215913757682 ], [ 1386088.458339030388743, 5859656.652665913105011 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1236", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 779.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_353_generated", "manhole_dn": "manhole_354_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386088.458339030388743, 5859656.652665913105011 ], [ 1386075.652030121767893, 5859704.419184413738549 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1237", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 779.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_354_generated", "manhole_dn": "manhole_355_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386075.652030121767893, 5859704.419184413738549 ], [ 1386076.574770522769541, 5859754.410392354242504 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1238", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_355_generated", "manhole_dn": "manhole_356_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386076.574770522769541, 5859754.410392354242504 ], [ 1386077.497510923538357, 5859804.401600294746459 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1239", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_356_generated", "manhole_dn": "manhole_357_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386077.497510923538357, 5859804.401600294746459 ], [ 1386078.420251324307173, 5859854.392808235250413 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E195", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 814.29998779296875, "elevtn_dn": 802.9000244140625, "invlev_up": 811.79998779296875, "invlev_dn": 800.4000244140625, "manhole_up": "manhole_358_generated", "manhole_dn": "manhole_359_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384050.267680946970358, 5856698.702001548372209 ], [ 1384085.778961833100766, 5856733.441067186184227 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E196", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 802.9000244140625, "elevtn_dn": 802.9000244140625, "invlev_up": 800.4000244140625, "invlev_dn": 800.4000244140625, "manhole_up": "manhole_359_generated", "manhole_dn": "manhole_360_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384085.778961833100766, 5856733.441067186184227 ], [ 1384122.993944165529683, 5856766.592179889790714 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E197", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 802.9000244140625, "elevtn_dn": 816.29998779296875, "invlev_up": 800.4000244140625, "invlev_dn": 813.79998779296875, "manhole_up": "manhole_360_generated", "manhole_dn": "manhole_361_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384122.993944165529683, 5856766.592179889790714 ], [ 1384160.350959801580757, 5856799.578122235834599 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E198", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.29998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 813.79998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_361_generated", "manhole_dn": "manhole_362_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384160.350959801580757, 5856799.578122235834599 ], [ 1384198.384374253917485, 5856831.724873264320195 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E199", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 798.29998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_362_generated", "manhole_dn": "manhole_363_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384198.384374253917485, 5856831.724873264320195 ], [ 1384230.112839305773377, 5856870.159957353956997 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E200", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 793.9000244140625, "invlev_up": 798.29998779296875, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_363_generated", "manhole_dn": "manhole_364_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384230.112839305773377, 5856870.159957353956997 ], [ 1384259.121702386764809, 5856910.628996902145445 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E201", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 807.60003662109375, "invlev_up": 791.4000244140625, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_364_generated", "manhole_dn": "manhole_365_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384259.121702386764809, 5856910.628996902145445 ], [ 1384287.023718592710793, 5856951.925833041779697 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E202", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_365_generated", "manhole_dn": "manhole_366_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384287.023718592710793, 5856951.925833041779697 ], [ 1384314.929269487503916, 5856993.22028074786067 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E203", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_366_generated", "manhole_dn": "manhole_367_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384314.929269487503916, 5856993.22028074786067 ], [ 1384344.819752591196448, 5857033.056208833120763 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E204", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_367_generated", "manhole_dn": "manhole_368_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384344.819752591196448, 5857033.056208833120763 ], [ 1384375.891110281459987, 5857072.024425559677184 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E205", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_368_generated", "manhole_dn": "manhole_369_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384375.891110281459987, 5857072.024425559677184 ], [ 1384412.732155854580924, 5857105.507668288424611 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E206", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_369_generated", "manhole_dn": "manhole_370_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384412.732155854580924, 5857105.507668288424611 ], [ 1384450.07948348694481, 5857138.509612204506993 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E207", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_370_generated", "manhole_dn": "manhole_371_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384450.07948348694481, 5857138.509612204506993 ], [ 1384487.42686335532926, 5857171.511497005820274 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E208", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 805.0, "invlev_up": 793.4000244140625, "invlev_dn": 802.5, "manhole_up": "manhole_371_generated", "manhole_dn": "manhole_372_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384487.42686335532926, 5857171.511497005820274 ], [ 1384525.207759798038751, 5857204.014277670532465 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E209", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 796.29998779296875, "invlev_up": 802.5, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_372_generated", "manhole_dn": "manhole_373_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384525.207759798038751, 5857204.014277670532465 ], [ 1384563.111988977529109, 5857236.375065575353801 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E210", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 796.29998779296875, "invlev_up": 793.79998779296875, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_373_generated", "manhole_dn": "manhole_374_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384563.111988977529109, 5857236.375065575353801 ], [ 1384601.016218156786636, 5857268.735853480175138 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E211", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 786.10003662109375, "invlev_up": 793.79998779296875, "invlev_dn": 783.60003662109375, "manhole_up": "manhole_374_generated", "manhole_dn": "manhole_375_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384601.016218156786636, 5857268.735853480175138 ], [ 1384638.920447336044163, 5857301.096641384996474 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E212", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.10003662109375, "elevtn_dn": 794.29998779296875, "invlev_up": 783.60003662109375, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_375_generated", "manhole_dn": "manhole_376_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384638.920447336044163, 5857301.096641384996474 ], [ 1384669.604954990325496, 5857340.313404724933207 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E213", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 794.29998779296875, "invlev_up": 791.79998779296875, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_376_generated", "manhole_dn": "manhole_377_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384669.604954990325496, 5857340.313404724933207 ], [ 1384699.518247769214213, 5857380.104403200559318 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E214", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 794.29998779296875, "invlev_up": 791.79998779296875, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_377_generated", "manhole_dn": "manhole_378_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384699.518247769214213, 5857380.104403200559318 ], [ 1384719.806332413339987, 5857425.627417215146124 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E215", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 782.0, "invlev_up": 791.79998779296875, "invlev_dn": 779.5, "manhole_up": "manhole_378_generated", "manhole_dn": "manhole_379_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384719.806332413339987, 5857425.627417215146124 ], [ 1384740.094417057465762, 5857471.150431229732931 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E216", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 782.0, "elevtn_dn": 789.70001220703125, "invlev_up": 779.5, "invlev_dn": 787.20001220703125, "manhole_up": "manhole_379_generated", "manhole_dn": "manhole_380_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384740.094417057465762, 5857471.150431229732931 ], [ 1384760.382501701591536, 5857516.673445244319737 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E217", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 789.70001220703125, "elevtn_dn": 789.70001220703125, "invlev_up": 787.20001220703125, "invlev_dn": 787.20001220703125, "manhole_up": "manhole_380_generated", "manhole_dn": "manhole_381_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384760.382501701591536, 5857516.673445244319737 ], [ 1384780.670586345717311, 5857562.196459258906543 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E218", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 789.70001220703125, "elevtn_dn": 796.5, "invlev_up": 787.20001220703125, "invlev_dn": 794.0, "manhole_up": "manhole_381_generated", "manhole_dn": "manhole_382_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384780.670586345717311, 5857562.196459258906543 ], [ 1384802.672203443944454, 5857606.838341221213341 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E219", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 796.5, "elevtn_dn": 771.9000244140625, "invlev_up": 794.0, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_382_generated", "manhole_dn": "manhole_383_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384802.672203443944454, 5857606.838341221213341 ], [ 1384827.896526007680222, 5857649.823044718243182 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E220", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_383_generated", "manhole_dn": "manhole_384_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384827.896526007680222, 5857649.823044718243182 ], [ 1384854.757882944308221, 5857691.606820800341666 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E221", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_384_generated", "manhole_dn": "manhole_385_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384854.757882944308221, 5857691.606820800341666 ], [ 1384888.185768931638449, 5857728.573395187035203 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E222", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_385_generated", "manhole_dn": "manhole_386_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384888.185768931638449, 5857728.573395187035203 ], [ 1384921.613654918735847, 5857765.539969574660063 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E223", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 755.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_386_generated", "manhole_dn": "manhole_387_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384921.613654918735847, 5857765.539969574660063 ], [ 1384956.145453942706808, 5857801.445756647735834 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E224", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 755.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_387_generated", "manhole_dn": "manhole_388_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384956.145453942706808, 5857801.445756647735834 ], [ 1384991.751306539867073, 5857836.319449373520911 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E225", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 746.0, "invlev_up": 755.4000244140625, "invlev_dn": 743.5, "manhole_up": "manhole_388_generated", "manhole_dn": "manhole_389_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384991.751306539867073, 5857836.319449373520911 ], [ 1385027.357159137027338, 5857871.193142099305987 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E226", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 746.0, "elevtn_dn": 755.79998779296875, "invlev_up": 743.5, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_389_generated", "manhole_dn": "manhole_390_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385027.357159137027338, 5857871.193142099305987 ], [ 1385062.963011734187603, 5857906.066834825091064 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E227", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 728.60003662109375, "invlev_up": 753.29998779296875, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_390_generated", "manhole_dn": "manhole_391_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385062.963011734187603, 5857906.066834825091064 ], [ 1385098.568864331347868, 5857940.940527551807463 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E228", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 728.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_391_generated", "manhole_dn": "manhole_392_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385098.568864331347868, 5857940.940527551807463 ], [ 1385135.753846400883049, 5857974.029479116201401 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E229", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 728.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_392_generated", "manhole_dn": "manhole_393_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385135.753846400883049, 5857974.029479116201401 ], [ 1385175.738456205930561, 5858003.622975903563201 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E230", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 735.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 733.10003662109375, "manhole_up": "manhole_393_generated", "manhole_dn": "manhole_394_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385175.738456205930561, 5858003.622975903563201 ], [ 1385218.653756857383996, 5858028.965196672827005 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E231", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 735.60003662109375, "elevtn_dn": 735.60003662109375, "invlev_up": 733.10003662109375, "invlev_dn": 733.10003662109375, "manhole_up": "manhole_394_generated", "manhole_dn": "manhole_395_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385218.653756857383996, 5858028.965196672827005 ], [ 1385262.454936756985262, 5858052.706982978619635 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E232", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 735.60003662109375, "elevtn_dn": 742.0, "invlev_up": 733.10003662109375, "invlev_dn": 739.5, "manhole_up": "manhole_395_generated", "manhole_dn": "manhole_396_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385262.454936756985262, 5858052.706982978619635 ], [ 1385306.715555034345016, 5858075.618745312094688 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E233", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 742.0, "elevtn_dn": 742.0, "invlev_up": 739.5, "invlev_dn": 739.5, "manhole_up": "manhole_396_generated", "manhole_dn": "manhole_397_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385306.715555034345016, 5858075.618745312094688 ], [ 1385350.97617331170477, 5858098.530507644638419 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E234", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 742.0, "elevtn_dn": 736.0, "invlev_up": 739.5, "invlev_dn": 733.5, "manhole_up": "manhole_397_generated", "manhole_dn": "manhole_398_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385350.97617331170477, 5858098.530507644638419 ], [ 1385395.236791589297354, 5858121.442269978113472 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E235", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 736.0, "elevtn_dn": 736.0, "invlev_up": 733.5, "invlev_dn": 733.5, "manhole_up": "manhole_398_generated", "manhole_dn": "manhole_399_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385395.236791589297354, 5858121.442269978113472 ], [ 1385439.497409866657108, 5858144.354032310657203 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E236", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 736.0, "elevtn_dn": 737.9000244140625, "invlev_up": 733.5, "invlev_dn": 735.4000244140625, "manhole_up": "manhole_399_generated", "manhole_dn": "manhole_400_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385439.497409866657108, 5858144.354032310657203 ], [ 1385483.758028144016862, 5858167.265794644132257 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E237", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.9000244140625, "elevtn_dn": 737.9000244140625, "invlev_up": 735.4000244140625, "invlev_dn": 735.4000244140625, "manhole_up": "manhole_400_generated", "manhole_dn": "manhole_401_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385483.758028144016862, 5858167.265794644132257 ], [ 1385528.018646421376616, 5858190.17755697760731 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E238", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.9000244140625, "elevtn_dn": 727.29998779296875, "invlev_up": 735.4000244140625, "invlev_dn": 724.79998779296875, "manhole_up": "manhole_401_generated", "manhole_dn": "manhole_402_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385528.018646421376616, 5858190.17755697760731 ], [ 1385571.606102279853076, 5858214.277655217796564 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E239", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 727.29998779296875, "elevtn_dn": 727.29998779296875, "invlev_up": 724.79998779296875, "invlev_dn": 724.79998779296875, "manhole_up": "manhole_402_generated", "manhole_dn": "manhole_403_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385571.606102279853076, 5858214.277655217796564 ], [ 1385614.013400863157585, 5858240.461089110001922 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E240", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 727.29998779296875, "elevtn_dn": 690.60003662109375, "invlev_up": 724.79998779296875, "invlev_dn": 688.10003662109375, "manhole_up": "manhole_403_generated", "manhole_dn": "manhole_404_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385614.013400863157585, 5858240.461089110001922 ], [ 1385656.420699446462095, 5858266.644523002207279 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E241", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 690.60003662109375, "elevtn_dn": 733.60003662109375, "invlev_up": 688.10003662109375, "invlev_dn": 731.10003662109375, "manhole_up": "manhole_404_generated", "manhole_dn": "manhole_405_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385656.420699446462095, 5858266.644523002207279 ], [ 1385698.773111530812457, 5858292.8961898451671 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E242", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 733.60003662109375, "elevtn_dn": 733.60003662109375, "invlev_up": 731.10003662109375, "invlev_dn": 731.10003662109375, "manhole_up": "manhole_405_generated", "manhole_dn": "manhole_406_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385698.773111530812457, 5858292.8961898451671 ], [ 1385733.435650466475636, 5858328.707634637132287 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E243", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 733.60003662109375, "elevtn_dn": 721.60003662109375, "invlev_up": 731.10003662109375, "invlev_dn": 719.10003662109375, "manhole_up": "manhole_406_generated", "manhole_dn": "manhole_407_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385733.435650466475636, 5858328.707634637132287 ], [ 1385768.098189401905984, 5858364.519079428166151 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E244", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 721.60003662109375, "elevtn_dn": 721.60003662109375, "invlev_up": 719.10003662109375, "invlev_dn": 719.10003662109375, "manhole_up": "manhole_407_generated", "manhole_dn": "manhole_408_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385768.098189401905984, 5858364.519079428166151 ], [ 1385795.882535298354924, 5858405.467093757353723 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E245", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 721.60003662109375, "elevtn_dn": 739.0, "invlev_up": 719.10003662109375, "invlev_dn": 736.5, "manhole_up": "manhole_408_generated", "manhole_dn": "manhole_409_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385795.882535298354924, 5858405.467093757353723 ], [ 1385820.377634756267071, 5858448.871486231684685 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E246", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 727.79998779296875, "invlev_up": 736.5, "invlev_dn": 725.29998779296875, "manhole_up": "manhole_409_generated", "manhole_dn": "manhole_410_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385820.377634756267071, 5858448.871486231684685 ], [ 1385841.084314390551299, 5858493.920932004228234 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E247", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 727.79998779296875, "elevtn_dn": 727.79998779296875, "invlev_up": 725.29998779296875, "invlev_dn": 725.29998779296875, "manhole_up": "manhole_410_generated", "manhole_dn": "manhole_411_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385841.084314390551299, 5858493.920932004228234 ], [ 1385856.076261736918241, 5858541.451897682622075 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E248", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 727.79998779296875, "elevtn_dn": 734.9000244140625, "invlev_up": 725.29998779296875, "invlev_dn": 732.4000244140625, "manhole_up": "manhole_411_generated", "manhole_dn": "manhole_412_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385856.076261736918241, 5858541.451897682622075 ], [ 1385865.668899663724005, 5858590.250006795860827 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E249", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 734.9000244140625, "elevtn_dn": 734.9000244140625, "invlev_up": 732.4000244140625, "invlev_dn": 732.4000244140625, "manhole_up": "manhole_412_generated", "manhole_dn": "manhole_413_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385865.668899663724005, 5858590.250006795860827 ], [ 1385873.387286560609937, 5858639.487976770848036 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E250", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 734.9000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 732.4000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_413_generated", "manhole_dn": "manhole_414_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385873.387286560609937, 5858639.487976770848036 ], [ 1385875.017949819331989, 5858689.287253175862134 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E251", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 748.9000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_414_generated", "manhole_dn": "manhole_415_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385875.017949819331989, 5858689.287253175862134 ], [ 1385876.432928551919758, 5858739.106416343711317 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E252", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 748.9000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_415_generated", "manhole_dn": "manhole_416_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385876.432928551919758, 5858739.106416343711317 ], [ 1385878.329821793129668, 5858788.908141564577818 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E253", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 748.9000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_416_generated", "manhole_dn": "manhole_417_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385878.329821793129668, 5858788.908141564577818 ], [ 1385880.51921496167779, 5858838.69928275514394 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E254", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_417_generated", "manhole_dn": "manhole_418_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385880.51921496167779, 5858838.69928275514394 ], [ 1385882.620351102668792, 5858888.493530485779047 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E255", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_418_generated", "manhole_dn": "manhole_419_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385882.620351102668792, 5858888.493530485779047 ], [ 1385883.937443709466606, 5858938.315377607010305 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E256", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 766.10003662109375, "invlev_up": 757.20001220703125, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_419_generated", "manhole_dn": "manhole_420_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385883.937443709466606, 5858938.315377607010305 ], [ 1385885.254538560518995, 5858988.137224668636918 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E257", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 766.10003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_420_generated", "manhole_dn": "manhole_421_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385885.254538560518995, 5858988.137224668636918 ], [ 1385890.650534195825458, 5859037.630400610156357 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E258", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 766.10003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_421_generated", "manhole_dn": "manhole_422_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385890.650534195825458, 5859037.630400610156357 ], [ 1385901.777442803606391, 5859086.09239396546036 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E259", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 768.60003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 766.10003662109375, "manhole_up": "manhole_422_generated", "manhole_dn": "manhole_423_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385901.777442803606391, 5859086.09239396546036 ], [ 1385915.397954803425819, 5859134.03436760418117 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E260", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.60003662109375, "elevtn_dn": 762.79998779296875, "invlev_up": 766.10003662109375, "invlev_dn": 760.29998779296875, "manhole_up": "manhole_423_generated", "manhole_dn": "manhole_424_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385915.397954803425819, 5859134.03436760418117 ], [ 1385928.42605347908102, 5859182.139209139160812 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E261", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.79998779296875, "elevtn_dn": 762.5, "invlev_up": 760.29998779296875, "invlev_dn": 760.0, "manhole_up": "manhole_424_generated", "manhole_dn": "manhole_425_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385928.42605347908102, 5859182.139209139160812 ], [ 1385941.228082312969491, 5859230.306202415376902 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E262", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 762.5, "invlev_up": 760.0, "invlev_dn": 760.0, "manhole_up": "manhole_425_generated", "manhole_dn": "manhole_426_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385941.228082312969491, 5859230.306202415376902 ], [ 1385945.092689140234143, 5859279.734331246465445 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E263", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 762.5, "invlev_up": 760.0, "invlev_dn": 760.0, "manhole_up": "manhole_426_generated", "manhole_dn": "manhole_427_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385945.092689140234143, 5859279.734331246465445 ], [ 1385937.902412303024903, 5859328.779896341264248 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E264", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 778.0, "invlev_up": 760.0, "invlev_dn": 775.5, "manhole_up": "manhole_427_generated", "manhole_dn": "manhole_428_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.902412303024903, 5859328.779896341264248 ], [ 1385932.795075723901391, 5859378.173214216716588 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E265", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 778.0, "invlev_up": 775.5, "invlev_dn": 775.5, "manhole_up": "manhole_428_generated", "manhole_dn": "manhole_429_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385932.795075723901391, 5859378.173214216716588 ], [ 1385937.702695531537756, 5859427.770254967734218 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E266", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 778.0, "invlev_up": 775.5, "invlev_dn": 775.5, "manhole_up": "manhole_429_generated", "manhole_dn": "manhole_430_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.702695531537756, 5859427.770254967734218 ], [ 1385939.035937832202762, 5859477.50230407807976 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E267", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 795.9000244140625, "invlev_up": 775.5, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_430_generated", "manhole_dn": "manhole_431_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385939.035937832202762, 5859477.50230407807976 ], [ 1385937.883638251805678, 5859527.328234969638288 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E268", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_431_generated", "manhole_dn": "manhole_432_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.883638251805678, 5859527.328234969638288 ], [ 1385940.515994266141206, 5859576.989168248139322 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E269", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_432_generated", "manhole_dn": "manhole_433_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385940.515994266141206, 5859576.989168248139322 ], [ 1385950.701545101590455, 5859625.530176519416273 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E270", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 815.0, "invlev_up": 793.4000244140625, "invlev_dn": 812.5, "manhole_up": "manhole_433_generated", "manhole_dn": "manhole_434_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385950.701545101590455, 5859625.530176519416273 ], [ 1385970.467743494315073, 5859670.991298755630851 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E271", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 815.0, "elevtn_dn": 815.0, "invlev_up": 812.5, "invlev_dn": 812.5, "manhole_up": "manhole_434_generated", "manhole_dn": "manhole_435_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385970.467743494315073, 5859670.991298755630851 ], [ 1386011.983088220236823, 5859697.862916950136423 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E272", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 815.0, "elevtn_dn": 779.79998779296875, "invlev_up": 812.5, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_435_generated", "manhole_dn": "manhole_436_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386011.983088220236823, 5859697.862916950136423 ], [ 1386052.213596233632416, 5859727.119808158837259 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E273", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_436_generated", "manhole_dn": "manhole_437_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386052.213596233632416, 5859727.119808158837259 ], [ 1386046.501012831227854, 5859771.612671964801848 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E274", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_437_generated", "manhole_dn": "manhole_438_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386046.501012831227854, 5859771.612671964801848 ], [ 1386026.809695787727833, 5859816.873920152895153 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E275", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_438_generated", "manhole_dn": "manhole_439_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386026.809695787727833, 5859816.873920152895153 ], [ 1386030.149607364553958, 5859866.379009906202555 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E276", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_439_generated", "manhole_dn": "manhole_440_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386030.149607364553958, 5859866.379009906202555 ], [ 1386045.250939248362556, 5859913.859036295674741 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_11_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 798.29998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_441_generated", "manhole_dn": "manhole_442_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384196.861816460033879, 5856829.88048410974443 ], [ 1384235.22519311751239, 5856854.977665597572923 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_11_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 793.9000244140625, "invlev_up": 798.29998779296875, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_442_generated", "manhole_dn": "manhole_443_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384235.22519311751239, 5856854.977665597572923 ], [ 1384263.450329831801355, 5856892.038370934315026 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_11_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 793.9000244140625, "invlev_up": 791.4000244140625, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_443_generated", "manhole_dn": "manhole_444_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384263.450329831801355, 5856892.038370934315026 ], [ 1384291.675466545857489, 5856929.099076271057129 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_11_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 807.60003662109375, "invlev_up": 791.4000244140625, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_444_generated", "manhole_dn": "manhole_445_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384291.675466545857489, 5856929.099076271057129 ], [ 1384319.900603260146454, 5856966.159781608730555 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_11_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_445_generated", "manhole_dn": "manhole_446_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384319.900603260146454, 5856966.159781608730555 ], [ 1384347.205867683747783, 5857003.894510924816132 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_11_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 799.0, "invlev_up": 805.10003662109375, "invlev_dn": 796.5, "manhole_up": "manhole_446_generated", "manhole_dn": "manhole_447_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384347.205867683747783, 5857003.894510924816132 ], [ 1384380.322691001230851, 5857036.360282040201128 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_11_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 799.0, "elevtn_dn": 807.60003662109375, "invlev_up": 796.5, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_447_generated", "manhole_dn": "manhole_448_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384380.322691001230851, 5857036.360282040201128 ], [ 1384415.156610523350537, 5857067.291694445535541 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_11_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_448_generated", "manhole_dn": "manhole_449_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384415.156610523350537, 5857067.291694445535541 ], [ 1384449.343575850594789, 5857098.828100205399096 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_11_E8", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_449_generated", "manhole_dn": "manhole_450_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384449.343575850594789, 5857098.828100205399096 ], [ 1384470.004810179118067, 5857139.926174183376133 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_11_E9", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_450_generated", "manhole_dn": "manhole_451_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384470.004810179118067, 5857139.926174183376133 ], [ 1384484.18076178082265, 5857184.301805094815791 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_12_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_452_generated", "manhole_dn": "manhole_453_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384289.06552429520525, 5856954.947841017507017 ], [ 1384305.049610810354352, 5856994.88734863139689 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_12_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_453_generated", "manhole_dn": "manhole_454_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384305.049610810354352, 5856994.88734863139689 ], [ 1384321.033697325503454, 5857034.82685624435544 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_12_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 799.0, "invlev_up": 805.10003662109375, "invlev_dn": 796.5, "manhole_up": "manhole_454_generated", "manhole_dn": "manhole_455_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384321.033697325503454, 5857034.82685624435544 ], [ 1384347.445656489115208, 5857068.672038841992617 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_12_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 799.0, "elevtn_dn": 807.60003662109375, "invlev_up": 796.5, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_455_generated", "manhole_dn": "manhole_456_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384347.445656489115208, 5857068.672038841992617 ], [ 1384374.130628447979689, 5857102.406951548531651 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_12_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_456_generated", "manhole_dn": "manhole_457_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384374.130628447979689, 5857102.406951548531651 ], [ 1384399.587644136510789, 5857137.08541233278811 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_12_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_457_generated", "manhole_dn": "manhole_458_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384399.587644136510789, 5857137.08541233278811 ], [ 1384425.04465982504189, 5857171.763873117044568 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_12_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_458_generated", "manhole_dn": "manhole_459_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384425.04465982504189, 5857171.763873117044568 ], [ 1384456.866520966170356, 5857200.577977900393307 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_15_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_15", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_15", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_459_generated", "manhole_dn": "manhole_460_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384456.866520966170356, 5857200.577977900393307 ], [ 1384480.774830641923472, 5857195.244455400854349 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_17_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_17", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_17", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 805.0, "invlev_up": 793.4000244140625, "invlev_dn": 802.5, "manhole_up": "manhole_459_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384456.866520966170356, 5857200.577977900393307 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_18_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_18", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_18", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_462_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384493.329776774393395, 5857201.952337642200291 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_19_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_19", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_19", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_462_generated", "manhole_dn": "manhole_463_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384493.329776774393395, 5857201.952337642200291 ], [ 1384511.321100181667134, 5857246.008046119473875 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_19_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_19", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_19", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_463_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384511.321100181667134, 5857246.008046119473875 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 796.29998779296875, "invlev_up": 802.5, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_464_generated", "manhole_dn": "manhole_465_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384512.484966830350459, 5857248.858029337599874 ], [ 1384550.208547196350992, 5857281.609186780638993 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 796.29998779296875, "invlev_up": 793.79998779296875, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_465_generated", "manhole_dn": "manhole_466_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384550.208547196350992, 5857281.609186780638993 ], [ 1384587.932127562351525, 5857314.360344224609435 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 809.10003662109375, "invlev_up": 793.79998779296875, "invlev_dn": 806.60003662109375, "manhole_up": "manhole_466_generated", "manhole_dn": "manhole_467_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384587.932127562351525, 5857314.360344224609435 ], [ 1384608.456866907887161, 5857358.785165345296264 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.10003662109375, "elevtn_dn": 809.10003662109375, "invlev_up": 806.60003662109375, "invlev_dn": 806.60003662109375, "manhole_up": "manhole_467_generated", "manhole_dn": "manhole_468_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384608.456866907887161, 5857358.785165345296264 ], [ 1384624.966163935838267, 5857405.935456342995167 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.10003662109375, "elevtn_dn": 794.29998779296875, "invlev_up": 806.60003662109375, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_468_generated", "manhole_dn": "manhole_469_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384624.966163935838267, 5857405.935456342995167 ], [ 1384639.938245237572119, 5857453.586039477027953 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 812.4000244140625, "invlev_up": 791.79998779296875, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_469_generated", "manhole_dn": "manhole_470_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384639.938245237572119, 5857453.586039477027953 ], [ 1384654.3423755497206, 5857501.421464210376143 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 812.4000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_470_generated", "manhole_dn": "manhole_471_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384654.3423755497206, 5857501.421464210376143 ], [ 1384665.748858094681054, 5857550.055336253717542 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 812.4000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_471_generated", "manhole_dn": "manhole_472_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384665.748858094681054, 5857550.055336253717542 ], [ 1384677.04772660904564, 5857598.717872150242329 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E8", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 818.9000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 816.4000244140625, "manhole_up": "manhole_472_generated", "manhole_dn": "manhole_473_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384677.04772660904564, 5857598.717872150242329 ], [ 1384688.346595123410225, 5857647.380408045835793 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E9", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 818.9000244140625, "elevtn_dn": 818.9000244140625, "invlev_up": 816.4000244140625, "invlev_dn": 816.4000244140625, "manhole_up": "manhole_473_generated", "manhole_dn": "manhole_474_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384688.346595123410225, 5857647.380408045835793 ], [ 1384699.64546363777481, 5857696.042943941429257 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E10", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 818.9000244140625, "elevtn_dn": 791.0, "invlev_up": 816.4000244140625, "invlev_dn": 788.5, "manhole_up": "manhole_474_generated", "manhole_dn": "manhole_475_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384699.64546363777481, 5857696.042943941429257 ], [ 1384710.944332152139395, 5857744.705479837954044 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E11", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 771.9000244140625, "invlev_up": 788.5, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_475_generated", "manhole_dn": "manhole_476_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384710.944332152139395, 5857744.705479837954044 ], [ 1384726.848783193388954, 5857791.671307560056448 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E12", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_476_generated", "manhole_dn": "manhole_477_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384726.848783193388954, 5857791.671307560056448 ], [ 1384753.929338480113074, 5857833.199649352580309 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E13", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_477_generated", "manhole_dn": "manhole_478_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384753.929338480113074, 5857833.199649352580309 ], [ 1384783.627482200739905, 5857873.006575288251042 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E14", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 791.0, "invlev_up": 769.4000244140625, "invlev_dn": 788.5, "manhole_up": "manhole_478_generated", "manhole_dn": "manhole_479_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384783.627482200739905, 5857873.006575288251042 ], [ 1384795.018452654592693, 5857920.637507135979831 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E15", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 791.0, "invlev_up": 788.5, "invlev_dn": 788.5, "manhole_up": "manhole_479_generated", "manhole_dn": "manhole_480_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384795.018452654592693, 5857920.637507135979831 ], [ 1384785.075932276435196, 5857969.445633230730891 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E16", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 820.10003662109375, "invlev_up": 788.5, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_480_generated", "manhole_dn": "manhole_481_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384785.075932276435196, 5857969.445633230730891 ], [ 1384771.479073295136914, 5858017.516749874688685 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E17", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 820.10003662109375, "invlev_up": 817.60003662109375, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_481_generated", "manhole_dn": "manhole_482_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384771.479073295136914, 5858017.516749874688685 ], [ 1384763.32518996251747, 5858066.675425447523594 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E18", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 820.10003662109375, "invlev_up": 817.60003662109375, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_482_generated", "manhole_dn": "manhole_483_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384763.32518996251747, 5858066.675425447523594 ], [ 1384757.405406558187678, 5858116.280495692044497 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E19", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 847.0, "invlev_up": 817.60003662109375, "invlev_dn": 844.5, "manhole_up": "manhole_483_generated", "manhole_dn": "manhole_484_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384757.405406558187678, 5858116.280495692044497 ], [ 1384746.211964494548738, 5858164.956996791996062 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E20", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 847.0, "invlev_up": 844.5, "invlev_dn": 844.5, "manhole_up": "manhole_484_generated", "manhole_dn": "manhole_485_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384746.211964494548738, 5858164.956996791996062 ], [ 1384738.028054837835953, 5858213.862443570047617 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E21", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 847.0, "invlev_up": 844.5, "invlev_dn": 844.5, "manhole_up": "manhole_485_generated", "manhole_dn": "manhole_486_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384738.028054837835953, 5858213.862443570047617 ], [ 1384756.479259133106098, 5858259.218586039729416 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E22", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 833.20001220703125, "invlev_up": 844.5, "invlev_dn": 830.70001220703125, "manhole_up": "manhole_486_generated", "manhole_dn": "manhole_487_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384756.479259133106098, 5858259.218586039729416 ], [ 1384792.653981153853238, 5858293.25339647103101 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E23", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 833.20001220703125, "elevtn_dn": 762.29998779296875, "invlev_up": 830.70001220703125, "invlev_dn": 759.79998779296875, "manhole_up": "manhole_487_generated", "manhole_dn": "manhole_488_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384792.653981153853238, 5858293.25339647103101 ], [ 1384839.146884107263759, 5858310.949097327888012 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E24", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.29998779296875, "elevtn_dn": 762.29998779296875, "invlev_up": 759.79998779296875, "invlev_dn": 759.79998779296875, "manhole_up": "manhole_488_generated", "manhole_dn": "manhole_489_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384839.146884107263759, 5858310.949097327888012 ], [ 1384888.517509665805846, 5858307.535864246077836 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E25", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.29998779296875, "elevtn_dn": 751.0, "invlev_up": 759.79998779296875, "invlev_dn": 748.5, "manhole_up": "manhole_489_generated", "manhole_dn": "manhole_490_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384888.517509665805846, 5858307.535864246077836 ], [ 1384936.622762819286436, 5858294.068231076002121 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E26", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.0, "elevtn_dn": 751.0, "invlev_up": 748.5, "invlev_dn": 748.5, "manhole_up": "manhole_490_generated", "manhole_dn": "manhole_491_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384936.622762819286436, 5858294.068231076002121 ], [ 1384984.637113286415115, 5858280.272530450485647 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E27", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.0, "elevtn_dn": 743.20001220703125, "invlev_up": 748.5, "invlev_dn": 740.70001220703125, "manhole_up": "manhole_491_generated", "manhole_dn": "manhole_492_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384984.637113286415115, 5858280.272530450485647 ], [ 1385032.633651287527755, 5858266.414710656739771 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E28", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 743.20001220703125, "elevtn_dn": 743.20001220703125, "invlev_up": 740.70001220703125, "invlev_dn": 740.70001220703125, "manhole_up": "manhole_492_generated", "manhole_dn": "manhole_493_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385032.633651287527755, 5858266.414710656739771 ], [ 1385081.886840383987874, 5858258.136644747108221 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E29", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 743.20001220703125, "elevtn_dn": 747.60003662109375, "invlev_up": 740.70001220703125, "invlev_dn": 745.10003662109375, "manhole_up": "manhole_493_generated", "manhole_dn": "manhole_494_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385081.886840383987874, 5858258.136644747108221 ], [ 1385131.310463621048257, 5858263.211211345158517 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E30", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.60003662109375, "elevtn_dn": 756.79998779296875, "invlev_up": 745.10003662109375, "invlev_dn": 754.29998779296875, "manhole_up": "manhole_494_generated", "manhole_dn": "manhole_495_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385131.310463621048257, 5858263.211211345158517 ], [ 1385177.729395114118233, 5858281.168494092300534 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E31", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.79998779296875, "elevtn_dn": 758.9000244140625, "invlev_up": 754.29998779296875, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_495_generated", "manhole_dn": "manhole_496_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385177.729395114118233, 5858281.168494092300534 ], [ 1385219.95651927171275, 5858307.84242575801909 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E32", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 758.9000244140625, "invlev_up": 756.4000244140625, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_496_generated", "manhole_dn": "manhole_497_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385219.95651927171275, 5858307.84242575801909 ], [ 1385261.864506913116202, 5858335.034840167500079 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E33", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 756.29998779296875, "invlev_up": 756.4000244140625, "invlev_dn": 753.79998779296875, "manhole_up": "manhole_497_generated", "manhole_dn": "manhole_498_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385261.864506913116202, 5858335.034840167500079 ], [ 1385305.658712412696332, 5858358.964500648900867 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E34", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 756.29998779296875, "invlev_up": 753.79998779296875, "invlev_dn": 753.79998779296875, "manhole_up": "manhole_498_generated", "manhole_dn": "manhole_499_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385305.658712412696332, 5858358.964500648900867 ], [ 1385350.136275847908109, 5858381.712097893469036 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E35", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 750.79998779296875, "invlev_up": 753.79998779296875, "invlev_dn": 748.29998779296875, "manhole_up": "manhole_499_generated", "manhole_dn": "manhole_500_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385350.136275847908109, 5858381.712097893469036 ], [ 1385394.617425152566284, 5858404.452682325616479 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E36", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 750.79998779296875, "elevtn_dn": 760.20001220703125, "invlev_up": 748.29998779296875, "invlev_dn": 757.70001220703125, "manhole_up": "manhole_500_generated", "manhole_dn": "manhole_501_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385394.617425152566284, 5858404.452682325616479 ], [ 1385439.245915542822331, 5858426.901898948475718 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E37", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 760.20001220703125, "elevtn_dn": 754.29998779296875, "invlev_up": 757.70001220703125, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_501_generated", "manhole_dn": "manhole_502_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385439.245915542822331, 5858426.901898948475718 ], [ 1385483.926139793125913, 5858449.248809035867453 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E38", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 754.29998779296875, "invlev_up": 751.79998779296875, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_502_generated", "manhole_dn": "manhole_503_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385483.926139793125913, 5858449.248809035867453 ], [ 1385525.860647091642022, 5858475.8632338559255 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E39", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 754.29998779296875, "invlev_up": 751.79998779296875, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_503_generated", "manhole_dn": "manhole_504_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385525.860647091642022, 5858475.8632338559255 ], [ 1385553.357332118786871, 5858517.404887572862208 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E40", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 751.70001220703125, "invlev_up": 751.79998779296875, "invlev_dn": 749.20001220703125, "manhole_up": "manhole_504_generated", "manhole_dn": "manhole_505_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385553.357332118786871, 5858517.404887572862208 ], [ 1385579.617479301057756, 5858559.686364834196866 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E41", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.70001220703125, "elevtn_dn": 751.70001220703125, "invlev_up": 749.20001220703125, "invlev_dn": 749.20001220703125, "manhole_up": "manhole_505_generated", "manhole_dn": "manhole_506_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385579.617479301057756, 5858559.686364834196866 ], [ 1385621.905693766893819, 5858585.068030893802643 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E42", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.70001220703125, "elevtn_dn": 750.9000244140625, "invlev_up": 749.20001220703125, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_506_generated", "manhole_dn": "manhole_507_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385621.905693766893819, 5858585.068030893802643 ], [ 1385664.027273919200525, 5858611.351026647724211 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E43", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 750.9000244140625, "invlev_up": 748.4000244140625, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_507_generated", "manhole_dn": "manhole_508_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385664.027273919200525, 5858611.351026647724211 ], [ 1385700.387205619364977, 5858645.507954810746014 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E44", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 750.9000244140625, "invlev_up": 748.4000244140625, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_508_generated", "manhole_dn": "manhole_509_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385700.387205619364977, 5858645.507954810746014 ], [ 1385734.601841112133116, 5858681.909404612146318 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E45", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 755.79998779296875, "invlev_up": 748.4000244140625, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_509_generated", "manhole_dn": "manhole_510_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385734.601841112133116, 5858681.909404612146318 ], [ 1385768.816476604901254, 5858718.310854412615299 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E46", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_510_generated", "manhole_dn": "manhole_511_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385768.816476604901254, 5858718.310854412615299 ], [ 1385802.200311921536922, 5858755.447309947572649 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E47", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_511_generated", "manhole_dn": "manhole_512_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385802.200311921536922, 5858755.447309947572649 ], [ 1385834.15946239954792, 5858793.844178703613579 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_21_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_21", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 765.0, "invlev_up": 753.79998779296875, "invlev_dn": 762.5, "manhole_up": "manhole_513_generated", "manhole_dn": "manhole_514_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385352.471788094611838, 5858398.70255031902343 ], [ 1385323.609449510695413, 5858430.098599229939282 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_21_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_21", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 765.0, "elevtn_dn": 765.0, "invlev_up": 762.5, "invlev_dn": 762.5, "manhole_up": "manhole_514_generated", "manhole_dn": "manhole_515_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385323.609449510695413, 5858430.098599229939282 ], [ 1385286.388775944709778, 5858419.306091710925102 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_21_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_21", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 765.0, "elevtn_dn": 758.9000244140625, "invlev_up": 762.5, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_515_generated", "manhole_dn": "manhole_516_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385286.388775944709778, 5858419.306091710925102 ], [ 1385252.458742934046313, 5858394.201654580421746 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_21_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_21", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 758.9000244140625, "invlev_up": 756.4000244140625, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_516_generated", "manhole_dn": "manhole_517_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385252.458742934046313, 5858394.201654580421746 ], [ 1385217.536378393415362, 5858369.72360460460186 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_21_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_21", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 756.79998779296875, "invlev_up": 756.4000244140625, "invlev_dn": 754.29998779296875, "manhole_up": "manhole_517_generated", "manhole_dn": "manhole_518_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385217.536378393415362, 5858369.72360460460186 ], [ 1385177.877519500209019, 5858363.975667187944055 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_23_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_23", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "manhole_up": "manhole_519_generated", "manhole_dn": "manhole_520_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384748.107251951703802, 5858475.46539437584579 ], [ 1384773.662756133358926, 5858482.028828926384449 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_23_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_23", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "manhole_up": "manhole_520_generated", "manhole_dn": "manhole_521_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384773.662756133358926, 5858482.028828926384449 ], [ 1384799.21826031524688, 5858488.592263477854431 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_24_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_24", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_24", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.9000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 760.4000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_522_generated", "manhole_dn": "manhole_523_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385831.554474999429658, 5858837.476550582796335 ], [ 1385834.933234154479578, 5858795.367517679929733 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_24_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_24", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_24", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 748.9000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_523_generated", "manhole_dn": "manhole_524_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385834.933234154479578, 5858795.367517679929733 ], [ 1385855.640895856311545, 5858836.135079927742481 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_25_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_25", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.79998779296875, "elevtn_dn": 791.20001220703125, "invlev_up": 784.29998779296875, "invlev_dn": 788.70001220703125, "manhole_up": "manhole_525_generated", "manhole_dn": "manhole_526_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385425.871741503709927, 5858809.522038951516151 ], [ 1385446.216239683330059, 5858844.397748519666493 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_25_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_25", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 791.20001220703125, "elevtn_dn": 791.20001220703125, "invlev_up": 788.70001220703125, "invlev_dn": 788.70001220703125, "manhole_up": "manhole_526_generated", "manhole_dn": "manhole_527_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385446.216239683330059, 5858844.397748519666493 ], [ 1385453.998638280900195, 5858886.437654017470777 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_25_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_25", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 791.20001220703125, "elevtn_dn": 783.0, "invlev_up": 788.70001220703125, "invlev_dn": 780.5, "manhole_up": "manhole_527_generated", "manhole_dn": "manhole_528_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385453.998638280900195, 5858886.437654017470777 ], [ 1385472.218053022632375, 5858925.273072509095073 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_26_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_26", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_26", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.9000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 760.4000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_522_generated", "manhole_dn": "manhole_524_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385831.554474999429658, 5858837.476550582796335 ], [ 1385855.640895856311545, 5858836.135079927742481 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_29_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_29", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_29", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_529_generated", "manhole_dn": "manhole_530_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385861.372513797832653, 5858893.832569030113518 ], [ 1385844.630084188189358, 5858865.848266057670116 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_29_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_29", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_29", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 762.9000244140625, "invlev_up": 757.20001220703125, "invlev_dn": 760.4000244140625, "manhole_up": "manhole_530_generated", "manhole_dn": "manhole_522_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385844.630084188189358, 5858865.848266057670116 ], [ 1385831.554474999429658, 5858837.476550582796335 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_30_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 769.4000244140625, "invlev_up": 766.9000244140625, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_531_generated", "manhole_dn": "manhole_532_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387137.22300889948383, 5858981.723106959834695 ], [ 1387148.04859330272302, 5859026.366797789931297 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_30_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 762.60003662109375, "invlev_up": 766.9000244140625, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_532_generated", "manhole_dn": "manhole_533_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387148.04859330272302, 5859026.366797789931297 ], [ 1387119.95937648974359, 5859056.934598693624139 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_30_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 762.60003662109375, "invlev_up": 760.10003662109375, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_533_generated", "manhole_dn": "manhole_534_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387119.95937648974359, 5859056.934598693624139 ], [ 1387074.832296247361228, 5859065.30100557859987 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_30_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 755.79998779296875, "invlev_up": 760.10003662109375, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_534_generated", "manhole_dn": "manhole_535_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387074.832296247361228, 5859065.30100557859987 ], [ 1387030.356415221933275, 5859076.86137125454843 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_30_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 772.4000244140625, "invlev_up": 753.29998779296875, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_535_generated", "manhole_dn": "manhole_536_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387030.356415221933275, 5859076.86137125454843 ], [ 1386986.427998587489128, 5859090.309648380614817 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_30_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 761.60003662109375, "invlev_up": 769.9000244140625, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_536_generated", "manhole_dn": "manhole_537_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386986.427998587489128, 5859090.309648380614817 ], [ 1386945.966695382725447, 5859111.788386604748666 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_30_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_537_generated", "manhole_dn": "manhole_538_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386945.966695382725447, 5859111.788386604748666 ], [ 1386905.77102447184734, 5859134.105928846634924 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_30_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_538_generated", "manhole_dn": "manhole_539_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386905.77102447184734, 5859134.105928846634924 ], [ 1386871.537448140559718, 5859162.609670763835311 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_539_generated", "manhole_dn": "manhole_540_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386871.537448140559718, 5859162.609670763835311 ], [ 1386921.106019288301468, 5859163.103915391489863 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 772.4000244140625, "invlev_up": 759.10003662109375, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_540_generated", "manhole_dn": "manhole_541_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386921.106019288301468, 5859163.103915391489863 ], [ 1386970.627896018791944, 5859161.624508504755795 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 772.4000244140625, "invlev_up": 769.9000244140625, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_541_generated", "manhole_dn": "manhole_542_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386970.627896018791944, 5859161.624508504755795 ], [ 1387019.993600395740941, 5859157.412991388700902 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 781.10003662109375, "invlev_up": 769.9000244140625, "invlev_dn": 778.60003662109375, "manhole_up": "manhole_542_generated", "manhole_dn": "manhole_543_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387019.993600395740941, 5859157.412991388700902 ], [ 1387069.191225855611265, 5859151.340004274621606 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 781.10003662109375, "elevtn_dn": 781.10003662109375, "invlev_up": 778.60003662109375, "invlev_dn": 778.60003662109375, "manhole_up": "manhole_543_generated", "manhole_dn": "manhole_544_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387069.191225855611265, 5859151.340004274621606 ], [ 1387118.547863835236058, 5859146.828392788767815 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 781.10003662109375, "elevtn_dn": 786.4000244140625, "invlev_up": 778.60003662109375, "invlev_dn": 783.9000244140625, "manhole_up": "manhole_544_generated", "manhole_dn": "manhole_545_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387118.547863835236058, 5859146.828392788767815 ], [ 1387167.916038708761334, 5859151.025294326245785 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.4000244140625, "elevtn_dn": 786.4000244140625, "invlev_up": 783.9000244140625, "invlev_dn": 783.9000244140625, "manhole_up": "manhole_545_generated", "manhole_dn": "manhole_546_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387167.916038708761334, 5859151.025294326245785 ], [ 1387217.282604865729809, 5859155.523034786805511 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.4000244140625, "elevtn_dn": 787.60003662109375, "invlev_up": 783.9000244140625, "invlev_dn": 785.10003662109375, "manhole_up": "manhole_546_generated", "manhole_dn": "manhole_547_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387217.282604865729809, 5859155.523034786805511 ], [ 1387266.649171022465453, 5859160.020775248296559 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E8", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 787.60003662109375, "elevtn_dn": 787.60003662109375, "invlev_up": 785.10003662109375, "invlev_dn": 785.10003662109375, "manhole_up": "manhole_547_generated", "manhole_dn": "manhole_548_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387266.649171022465453, 5859160.020775248296559 ], [ 1387315.831188223091885, 5859165.716172898188233 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E9", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 787.60003662109375, "elevtn_dn": 790.4000244140625, "invlev_up": 785.10003662109375, "invlev_dn": 787.9000244140625, "manhole_up": "manhole_548_generated", "manhole_dn": "manhole_549_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387315.831188223091885, 5859165.716172898188233 ], [ 1387364.261764668161049, 5859176.288154195994139 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E10", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 790.4000244140625, "elevtn_dn": 790.4000244140625, "invlev_up": 787.9000244140625, "invlev_dn": 787.9000244140625, "manhole_up": "manhole_549_generated", "manhole_dn": "manhole_550_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387364.261764668161049, 5859176.288154195994139 ], [ 1387411.186259990092367, 5859192.118345031514764 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E11", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 790.4000244140625, "elevtn_dn": 789.10003662109375, "invlev_up": 787.9000244140625, "invlev_dn": 786.60003662109375, "manhole_up": "manhole_550_generated", "manhole_dn": "manhole_551_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387411.186259990092367, 5859192.118345031514764 ], [ 1387455.544592748628929, 5859213.906051598489285 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E12", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 789.10003662109375, "elevtn_dn": 817.20001220703125, "invlev_up": 786.60003662109375, "invlev_dn": 814.70001220703125, "manhole_up": "manhole_551_generated", "manhole_dn": "manhole_552_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387455.544592748628929, 5859213.906051598489285 ], [ 1387490.610425172373652, 5859248.94134864397347 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E13", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 817.20001220703125, "elevtn_dn": 818.20001220703125, "invlev_up": 814.70001220703125, "invlev_dn": 815.70001220703125, "manhole_up": "manhole_552_generated", "manhole_dn": "manhole_553_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387490.610425172373652, 5859248.94134864397347 ], [ 1387525.979065561201423, 5859283.669168318621814 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E14", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 818.20001220703125, "elevtn_dn": 818.20001220703125, "invlev_up": 815.70001220703125, "invlev_dn": 815.70001220703125, "manhole_up": "manhole_553_generated", "manhole_dn": "manhole_554_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387525.979065561201423, 5859283.669168318621814 ], [ 1387563.532416822388768, 5859316.0270627560094 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E15", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 818.20001220703125, "elevtn_dn": 802.79998779296875, "invlev_up": 815.70001220703125, "invlev_dn": 800.29998779296875, "manhole_up": "manhole_554_generated", "manhole_dn": "manhole_555_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387563.532416822388768, 5859316.0270627560094 ], [ 1387601.085768083808944, 5859348.384957193396986 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E16", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 802.79998779296875, "elevtn_dn": 837.70001220703125, "invlev_up": 800.29998779296875, "invlev_dn": 835.20001220703125, "manhole_up": "manhole_555_generated", "manhole_dn": "manhole_556_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387601.085768083808944, 5859348.384957193396986 ], [ 1387638.639119345229119, 5859380.742851630784571 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E17", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 837.70001220703125, "elevtn_dn": 837.70001220703125, "invlev_up": 835.20001220703125, "invlev_dn": 835.20001220703125, "manhole_up": "manhole_556_generated", "manhole_dn": "manhole_557_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387638.639119345229119, 5859380.742851630784571 ], [ 1387676.192470606416464, 5859413.100746068172157 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E18", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 837.70001220703125, "elevtn_dn": 828.79998779296875, "invlev_up": 835.20001220703125, "invlev_dn": 826.29998779296875, "manhole_up": "manhole_557_generated", "manhole_dn": "manhole_558_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387676.192470606416464, 5859413.100746068172157 ], [ 1387713.745821867836639, 5859445.45864050462842 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E19", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 828.79998779296875, "elevtn_dn": 828.79998779296875, "invlev_up": 826.29998779296875, "invlev_dn": 826.29998779296875, "manhole_up": "manhole_558_generated", "manhole_dn": "manhole_559_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387713.745821867836639, 5859445.45864050462842 ], [ 1387750.394377880264074, 5859478.825171477161348 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E20", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 828.79998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 826.29998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_559_generated", "manhole_dn": "manhole_560_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387750.394377880264074, 5859478.825171477161348 ], [ 1387786.626276910537854, 5859512.656178202480078 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E21", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 851.79998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_560_generated", "manhole_dn": "manhole_561_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387786.626276910537854, 5859512.656178202480078 ], [ 1387822.858175940578803, 5859546.487184926867485 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E22", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 851.79998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_561_generated", "manhole_dn": "manhole_562_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387822.858175940578803, 5859546.487184926867485 ], [ 1387850.662340233800933, 5859586.980695966631174 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E23", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 891.20001220703125, "invlev_up": 851.79998779296875, "invlev_dn": 888.70001220703125, "manhole_up": "manhole_562_generated", "manhole_dn": "manhole_563_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387850.662340233800933, 5859586.980695966631174 ], [ 1387868.193221996771172, 5859633.330900657922029 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E24", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 891.20001220703125, "elevtn_dn": 876.20001220703125, "invlev_up": 888.70001220703125, "invlev_dn": 873.70001220703125, "manhole_up": "manhole_563_generated", "manhole_dn": "manhole_564_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387868.193221996771172, 5859633.330900657922029 ], [ 1387885.535610173596069, 5859679.769344814121723 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E25", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 876.20001220703125, "elevtn_dn": 876.20001220703125, "invlev_up": 873.70001220703125, "invlev_dn": 873.70001220703125, "manhole_up": "manhole_564_generated", "manhole_dn": "manhole_565_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387885.535610173596069, 5859679.769344814121723 ], [ 1387902.854485532967374, 5859726.216552678495646 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E26", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 876.20001220703125, "elevtn_dn": 898.29998779296875, "invlev_up": 873.70001220703125, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_565_generated", "manhole_dn": "manhole_566_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387902.854485532967374, 5859726.216552678495646 ], [ 1387920.137465380365029, 5859772.67713953461498 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E27", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 898.29998779296875, "invlev_up": 895.79998779296875, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_566_generated", "manhole_dn": "manhole_567_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387920.137465380365029, 5859772.67713953461498 ], [ 1387937.420445227529854, 5859819.137726389802992 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E28", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 898.29998779296875, "invlev_up": 895.79998779296875, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_567_generated", "manhole_dn": "manhole_568_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387937.420445227529854, 5859819.137726389802992 ], [ 1387948.863530882401392, 5859867.082766367122531 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E29", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 918.5, "invlev_up": 895.79998779296875, "invlev_dn": 916.0, "manhole_up": "manhole_568_generated", "manhole_dn": "manhole_569_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387948.863530882401392, 5859867.082766367122531 ], [ 1387950.013254075078294, 5859916.565449987538159 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E30", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 918.5, "invlev_up": 916.0, "invlev_dn": 916.0, "manhole_up": "manhole_569_generated", "manhole_dn": "manhole_570_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387950.013254075078294, 5859916.565449987538159 ], [ 1387947.430782878771424, 5859966.047936389222741 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E31", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 918.5, "invlev_up": 916.0, "invlev_dn": 916.0, "manhole_up": "manhole_570_generated", "manhole_dn": "manhole_571_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387947.430782878771424, 5859966.047936389222741 ], [ 1387943.997958281077445, 5860015.499966060742736 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E32", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 948.60003662109375, "invlev_up": 916.0, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_571_generated", "manhole_dn": "manhole_572_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387943.997958281077445, 5860015.499966060742736 ], [ 1387940.565133683150634, 5860064.951995733194053 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E33", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 948.60003662109375, "invlev_up": 946.10003662109375, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_572_generated", "manhole_dn": "manhole_573_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.565133683150634, 5860064.951995733194053 ], [ 1387945.371777657186612, 5860113.959104515612125 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E34", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 948.60003662109375, "invlev_up": 946.10003662109375, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_573_generated", "manhole_dn": "manhole_574_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387945.371777657186612, 5860113.959104515612125 ], [ 1387964.117816498270258, 5860159.736532494425774 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E35", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 940.5, "invlev_up": 946.10003662109375, "invlev_dn": 938.0, "manhole_up": "manhole_574_generated", "manhole_dn": "manhole_575_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387964.117816498270258, 5860159.736532494425774 ], [ 1387984.093857799191028, 5860205.104420888237655 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E36", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 940.5, "invlev_up": 938.0, "invlev_dn": 938.0, "manhole_up": "manhole_575_generated", "manhole_dn": "manhole_576_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387984.093857799191028, 5860205.104420888237655 ], [ 1388004.069899099878967, 5860250.472309282049537 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E37", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 940.5, "invlev_up": 938.0, "invlev_dn": 938.0, "manhole_up": "manhole_576_generated", "manhole_dn": "manhole_577_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388004.069899099878967, 5860250.472309282049537 ], [ 1388027.68692572391592, 5860293.896034284494817 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E38", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 971.70001220703125, "invlev_up": 938.0, "invlev_dn": 969.20001220703125, "manhole_up": "manhole_577_generated", "manhole_dn": "manhole_578_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388027.68692572391592, 5860293.896034284494817 ], [ 1388060.096315970877185, 5860331.348726416006684 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E39", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 971.70001220703125, "elevtn_dn": 935.5, "invlev_up": 969.20001220703125, "invlev_dn": 933.0, "manhole_up": "manhole_578_generated", "manhole_dn": "manhole_579_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388060.096315970877185, 5860331.348726416006684 ], [ 1388092.967688721138984, 5860368.453448176383972 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E40", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 935.5, "invlev_up": 933.0, "invlev_dn": 933.0, "manhole_up": "manhole_579_generated", "manhole_dn": "manhole_580_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388092.967688721138984, 5860368.453448176383972 ], [ 1388119.020827289205045, 5860410.510251956991851 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E41", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 949.9000244140625, "invlev_up": 933.0, "invlev_dn": 947.4000244140625, "manhole_up": "manhole_580_generated", "manhole_dn": "manhole_581_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388119.020827289205045, 5860410.510251956991851 ], [ 1388143.407622833969072, 5860453.667774203233421 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E42", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 949.9000244140625, "elevtn_dn": 924.60003662109375, "invlev_up": 947.4000244140625, "invlev_dn": 922.10003662109375, "manhole_up": "manhole_581_generated", "manhole_dn": "manhole_582_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388143.407622833969072, 5860453.667774203233421 ], [ 1388167.794418378733099, 5860496.82529644947499 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E43", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 924.60003662109375, "elevtn_dn": 924.60003662109375, "invlev_up": 922.10003662109375, "invlev_dn": 922.10003662109375, "manhole_up": "manhole_582_generated", "manhole_dn": "manhole_583_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388167.794418378733099, 5860496.82529644947499 ], [ 1388187.41186453984119, 5860542.097804954275489 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E44", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 924.60003662109375, "elevtn_dn": 942.4000244140625, "invlev_up": 922.10003662109375, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_583_generated", "manhole_dn": "manhole_584_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388187.41186453984119, 5860542.097804954275489 ], [ 1388193.385166377527639, 5860591.251542154699564 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E45", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 942.4000244140625, "invlev_up": 939.9000244140625, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_584_generated", "manhole_dn": "manhole_585_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388193.385166377527639, 5860591.251542154699564 ], [ 1388198.812296225922182, 5860640.524595490656793 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E46", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 942.4000244140625, "invlev_up": 939.9000244140625, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_585_generated", "manhole_dn": "manhole_586_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388198.812296225922182, 5860640.524595490656793 ], [ 1388204.239426074549556, 5860689.7976488256827 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E47", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 955.0, "invlev_up": 939.9000244140625, "invlev_dn": 952.5, "manhole_up": "manhole_586_generated", "manhole_dn": "manhole_587_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388204.239426074549556, 5860689.7976488256827 ], [ 1388184.484932377934456, 5860730.700381714850664 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E48", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_587_generated", "manhole_dn": "manhole_588_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388184.484932377934456, 5860730.700381714850664 ], [ 1388159.550175313837826, 5860759.392759991809726 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E49", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_588_generated", "manhole_dn": "manhole_589_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388159.550175313837826, 5860759.392759991809726 ], [ 1388171.988544700434431, 5860807.377908634953201 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E50", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_589_generated", "manhole_dn": "manhole_590_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388171.988544700434431, 5860807.377908634953201 ], [ 1388215.013825689908117, 5860825.214942933060229 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E51", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 941.10003662109375, "invlev_up": 952.5, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_590_generated", "manhole_dn": "manhole_591_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388215.013825689908117, 5860825.214942933060229 ], [ 1388264.397385431453586, 5860829.298032846301794 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E52", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_591_generated", "manhole_dn": "manhole_592_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388264.397385431453586, 5860829.298032846301794 ], [ 1388313.062299854354933, 5860837.304878970608115 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E53", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 937.5, "invlev_up": 938.60003662109375, "invlev_dn": 935.0, "manhole_up": "manhole_592_generated", "manhole_dn": "manhole_593_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388313.062299854354933, 5860837.304878970608115 ], [ 1388360.993895401246846, 5860849.948045967146754 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E54", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.5, "elevtn_dn": 937.5, "invlev_up": 935.0, "invlev_dn": 935.0, "manhole_up": "manhole_593_generated", "manhole_dn": "manhole_594_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388360.993895401246846, 5860849.948045967146754 ], [ 1388408.925490947905928, 5860862.591212964616716 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E55", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.5, "elevtn_dn": 937.60003662109375, "invlev_up": 935.0, "invlev_dn": 935.10003662109375, "manhole_up": "manhole_594_generated", "manhole_dn": "manhole_595_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388408.925490947905928, 5860862.591212964616716 ], [ 1388458.220990223577246, 5860866.957201769575477 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E56", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.60003662109375, "elevtn_dn": 937.60003662109375, "invlev_up": 935.10003662109375, "invlev_dn": 935.10003662109375, "manhole_up": "manhole_595_generated", "manhole_dn": "manhole_596_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388458.220990223577246, 5860866.957201769575477 ], [ 1388507.336333080893382, 5860873.218384950421751 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E57", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.60003662109375, "elevtn_dn": 941.20001220703125, "invlev_up": 935.10003662109375, "invlev_dn": 938.70001220703125, "manhole_up": "manhole_596_generated", "manhole_dn": "manhole_597_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388507.336333080893382, 5860873.218384950421751 ], [ 1388556.215695114107803, 5860881.470384138636291 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E58", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.20001220703125, "elevtn_dn": 941.20001220703125, "invlev_up": 938.70001220703125, "invlev_dn": 938.70001220703125, "manhole_up": "manhole_597_generated", "manhole_dn": "manhole_598_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388556.215695114107803, 5860881.470384138636291 ], [ 1388604.556662159739062, 5860892.361969010904431 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E59", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.20001220703125, "elevtn_dn": 943.10003662109375, "invlev_up": 938.70001220703125, "invlev_dn": 940.60003662109375, "manhole_up": "manhole_598_generated", "manhole_dn": "manhole_599_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388604.556662159739062, 5860892.361969010904431 ], [ 1388653.59940263046883, 5860897.15789801068604 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E60", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 943.10003662109375, "elevtn_dn": 943.10003662109375, "invlev_up": 940.60003662109375, "invlev_dn": 940.60003662109375, "manhole_up": "manhole_599_generated", "manhole_dn": "manhole_600_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388653.59940263046883, 5860897.15789801068604 ], [ 1388700.080393208190799, 5860881.090511013753712 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E61", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 943.10003662109375, "elevtn_dn": 946.10003662109375, "invlev_up": 940.60003662109375, "invlev_dn": 943.60003662109375, "manhole_up": "manhole_600_generated", "manhole_dn": "manhole_601_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388700.080393208190799, 5860881.090511013753712 ], [ 1388732.687003659084439, 5860844.794781206175685 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E62", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 946.10003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 943.60003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_601_generated", "manhole_dn": "manhole_602_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388732.687003659084439, 5860844.794781206175685 ], [ 1388755.953327334951609, 5860801.023035684600472 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E63", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 950.10003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_602_generated", "manhole_dn": "manhole_603_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388755.953327334951609, 5860801.023035684600472 ], [ 1388778.23369869007729, 5860756.84024004638195 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E64", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 950.10003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_603_generated", "manhole_dn": "manhole_604_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388778.23369869007729, 5860756.84024004638195 ], [ 1388792.950793598080054, 5860709.504263866692781 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E65", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 953.79998779296875, "invlev_up": 950.10003662109375, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_604_generated", "manhole_dn": "manhole_605_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388792.950793598080054, 5860709.504263866692781 ], [ 1388807.667888506315649, 5860662.168287687934935 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E66", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_605_generated", "manhole_dn": "manhole_606_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388807.667888506315649, 5860662.168287687934935 ], [ 1388819.224422588944435, 5860613.968191100284457 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E67", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 955.70001220703125, "invlev_up": 951.29998779296875, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_606_generated", "manhole_dn": "manhole_607_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388819.224422588944435, 5860613.968191100284457 ], [ 1388830.63825476472266, 5860565.72907877061516 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E68", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_607_generated", "manhole_dn": "manhole_608_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388830.63825476472266, 5860565.72907877061516 ], [ 1388842.052086940500885, 5860517.489966440014541 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E69", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_608_generated", "manhole_dn": "manhole_609_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388842.052086940500885, 5860517.489966440014541 ], [ 1388862.77624000934884, 5860472.578981296159327 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E70", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 964.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_609_generated", "manhole_dn": "manhole_610_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388862.77624000934884, 5860472.578981296159327 ], [ 1388884.529400010826066, 5860428.03588358964771 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E71", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 951.29998779296875, "invlev_up": 962.20001220703125, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_610_generated", "manhole_dn": "manhole_611_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388884.529400010826066, 5860428.03588358964771 ], [ 1388906.282637836178765, 5860383.492823889479041 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E72", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_611_generated", "manhole_dn": "manhole_612_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388906.282637836178765, 5860383.492823889479041 ], [ 1388933.946375871310011, 5860342.419800435192883 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E73", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_612_generated", "manhole_dn": "manhole_613_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388933.946375871310011, 5860342.419800435192883 ], [ 1388962.240715913940221, 5860301.717001453973353 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_33_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 752.29998779296875, "invlev_up": 759.10003662109375, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_539_generated", "manhole_dn": "manhole_614_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386871.537448140559718, 5859162.609670763835311 ], [ 1386825.19834817154333, 5859175.156894122250378 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_33_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 752.29998779296875, "invlev_up": 749.79998779296875, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_614_generated", "manhole_dn": "manhole_615_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386825.19834817154333, 5859175.156894122250378 ], [ 1386779.333999397465959, 5859189.44842192158103 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_33_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 738.0, "invlev_up": 749.79998779296875, "invlev_dn": 735.5, "manhole_up": "manhole_615_generated", "manhole_dn": "manhole_616_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386779.333999397465959, 5859189.44842192158103 ], [ 1386733.445003136992455, 5859203.660136871039867 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_33_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 738.0, "invlev_up": 735.5, "invlev_dn": 735.5, "manhole_up": "manhole_616_generated", "manhole_dn": "manhole_617_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386733.445003136992455, 5859203.660136871039867 ], [ 1386687.508546756347641, 5859217.718167688697577 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_33_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 763.29998779296875, "invlev_up": 735.5, "invlev_dn": 760.79998779296875, "manhole_up": "manhole_617_generated", "manhole_dn": "manhole_618_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386687.508546756347641, 5859217.718167688697577 ], [ 1386641.572090375469998, 5859231.776198507286608 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_33_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 763.29998779296875, "elevtn_dn": 763.29998779296875, "invlev_up": 760.79998779296875, "invlev_dn": 760.79998779296875, "manhole_up": "manhole_618_generated", "manhole_dn": "manhole_619_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386641.572090375469998, 5859231.776198507286608 ], [ 1386595.451642262749374, 5859245.168246414512396 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_33_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 763.29998779296875, "elevtn_dn": 754.60003662109375, "invlev_up": 760.79998779296875, "invlev_dn": 752.10003662109375, "manhole_up": "manhole_619_generated", "manhole_dn": "manhole_620_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386595.451642262749374, 5859245.168246414512396 ], [ 1386548.813360751140863, 5859256.685926430858672 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_33_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 754.60003662109375, "elevtn_dn": 754.60003662109375, "invlev_up": 752.10003662109375, "invlev_dn": 752.10003662109375, "manhole_up": "manhole_620_generated", "manhole_dn": "manhole_621_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386548.813360751140863, 5859256.685926430858672 ], [ 1386502.175079239532351, 5859268.203606447204947 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_33_E8", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 754.60003662109375, "elevtn_dn": 742.5, "invlev_up": 752.10003662109375, "invlev_dn": 740.0, "manhole_up": "manhole_621_generated", "manhole_dn": "manhole_622_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386502.175079239532351, 5859268.203606447204947 ], [ 1386455.354356503346935, 5859278.943273726850748 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_33_E9", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 742.5, "invlev_up": 740.0, "invlev_dn": 740.0, "manhole_up": "manhole_622_generated", "manhole_dn": "manhole_623_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386455.354356503346935, 5859278.943273726850748 ], [ 1386408.879239794565365, 5859290.671229789964855 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_33_E10", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 717.60003662109375, "invlev_up": 740.0, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_623_generated", "manhole_dn": "manhole_624_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386408.879239794565365, 5859290.671229789964855 ], [ 1386364.691368696978316, 5859309.518465746194124 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_33_E11", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 717.60003662109375, "invlev_up": 715.10003662109375, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_624_generated", "manhole_dn": "manhole_625_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386364.691368696978316, 5859309.518465746194124 ], [ 1386320.503497599391267, 5859328.365701701492071 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_33_E12", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 711.0, "invlev_up": 715.10003662109375, "invlev_dn": 708.5, "manhole_up": "manhole_625_generated", "manhole_dn": "manhole_626_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386320.503497599391267, 5859328.365701701492071 ], [ 1386273.173811787506565, 5859335.36546028777957 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 953.70001220703125, "invlev_up": 948.79998779296875, "invlev_dn": 951.20001220703125, "manhole_up": "manhole_10_generated", "manhole_dn": "manhole_627_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388946.301100668497384, 5860414.883977899327874 ], [ 1388922.246059404918924, 5860458.418739438988268 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.70001220703125, "elevtn_dn": 953.70001220703125, "invlev_up": 951.20001220703125, "invlev_dn": 951.20001220703125, "manhole_up": "manhole_627_generated", "manhole_dn": "manhole_628_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388922.246059404918924, 5860458.418739438988268 ], [ 1388900.295977992936969, 5860503.075897979550064 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 951.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_628_generated", "manhole_dn": "manhole_629_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388900.295977992936969, 5860503.075897979550064 ], [ 1388878.345896581187844, 5860547.733056520111859 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 953.79998779296875, "invlev_up": 953.20001220703125, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_629_generated", "manhole_dn": "manhole_630_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388878.345896581187844, 5860547.733056520111859 ], [ 1388856.887740465346724, 5860592.570927501656115 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_630_generated", "manhole_dn": "manhole_631_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388856.887740465346724, 5860592.570927501656115 ], [ 1388853.076019846601412, 5860641.795407227240503 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_631_generated", "manhole_dn": "manhole_632_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388853.076019846601412, 5860641.795407227240503 ], [ 1388856.119826921960339, 5860691.462329030036926 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 952.5, "invlev_up": 951.29998779296875, "invlev_dn": 950.0, "manhole_up": "manhole_632_generated", "manhole_dn": "manhole_633_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388856.119826921960339, 5860691.462329030036926 ], [ 1388859.163633997086436, 5860741.12925083283335 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.5, "elevtn_dn": 952.5, "invlev_up": 950.0, "invlev_dn": 950.0, "manhole_up": "manhole_633_generated", "manhole_dn": "manhole_634_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388859.163633997086436, 5860741.12925083283335 ], [ 1388862.207441072445363, 5860790.796172635629773 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E8", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.5, "elevtn_dn": 945.5, "invlev_up": 950.0, "invlev_dn": 943.0, "manhole_up": "manhole_634_generated", "manhole_dn": "manhole_635_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388862.207441072445363, 5860790.796172635629773 ], [ 1388866.356326055014506, 5860840.344227194786072 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E9", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 945.5, "invlev_up": 943.0, "invlev_dn": 943.0, "manhole_up": "manhole_635_generated", "manhole_dn": "manhole_636_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388866.356326055014506, 5860840.344227194786072 ], [ 1388873.944740658160299, 5860889.522310186177492 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E10", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 945.5, "invlev_up": 943.0, "invlev_dn": 943.0, "manhole_up": "manhole_636_generated", "manhole_dn": "manhole_637_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388873.944740658160299, 5860889.522310186177492 ], [ 1388883.17427325528115, 5860938.398467163555324 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E11", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 937.4000244140625, "invlev_up": 943.0, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_637_generated", "manhole_dn": "manhole_638_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388883.17427325528115, 5860938.398467163555324 ], [ 1388890.216840920504183, 5860987.212368851527572 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E12", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 937.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_638_generated", "manhole_dn": "manhole_639_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388890.216840920504183, 5860987.212368851527572 ], [ 1388884.322194910608232, 5861036.62209493201226 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E13", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 937.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_639_generated", "manhole_dn": "manhole_640_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388884.322194910608232, 5861036.62209493201226 ], [ 1388878.427548900712281, 5861086.031821011565626 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E14", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_640_generated", "manhole_dn": "manhole_641_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388878.427548900712281, 5861086.031821011565626 ], [ 1388872.532902890816331, 5861135.441547092050314 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E15", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 927.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_641_generated", "manhole_dn": "manhole_642_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388872.532902890816331, 5861135.441547092050314 ], [ 1388866.63825688092038, 5861184.851273172535002 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E16", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 927.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_642_generated", "manhole_dn": "manhole_643_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388866.63825688092038, 5861184.851273172535002 ], [ 1388854.620840607210994, 5861232.489912945777178 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E17", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 926.60003662109375, "invlev_up": 927.9000244140625, "invlev_dn": 924.10003662109375, "manhole_up": "manhole_643_generated", "manhole_dn": "manhole_644_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388854.620840607210994, 5861232.489912945777178 ], [ 1388833.22756120422855, 5861277.416469449177384 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E18", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 926.60003662109375, "elevtn_dn": 926.60003662109375, "invlev_up": 924.10003662109375, "invlev_dn": 924.10003662109375, "manhole_up": "manhole_644_generated", "manhole_dn": "manhole_645_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388833.22756120422855, 5861277.416469449177384 ], [ 1388811.834281801246107, 5861322.343025953508914 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E19", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 926.60003662109375, "elevtn_dn": 931.10003662109375, "invlev_up": 924.10003662109375, "invlev_dn": 928.60003662109375, "manhole_up": "manhole_645_generated", "manhole_dn": "manhole_646_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388811.834281801246107, 5861322.343025953508914 ], [ 1388790.441002398030832, 5861367.26958245690912 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E20", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 931.10003662109375, "elevtn_dn": 922.20001220703125, "invlev_up": 928.60003662109375, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_646_generated", "manhole_dn": "manhole_647_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388790.441002398030832, 5861367.26958245690912 ], [ 1388769.047722995048389, 5861412.196138960309327 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E21", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 922.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_647_generated", "manhole_dn": "manhole_648_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388769.047722995048389, 5861412.196138960309327 ], [ 1388747.654443592065945, 5861457.122695464640856 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E22", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 922.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_648_generated", "manhole_dn": "manhole_649_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388747.654443592065945, 5861457.122695464640856 ], [ 1388725.026126575190574, 5861501.410491958260536 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E23", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_649_generated", "manhole_dn": "manhole_650_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388725.026126575190574, 5861501.410491958260536 ], [ 1388700.725248141447082, 5861544.833241644315422 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E24", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_650_generated", "manhole_dn": "manhole_651_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388700.725248141447082, 5861544.833241644315422 ], [ 1388676.42436970770359, 5861588.255991329438984 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E25", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_651_generated", "manhole_dn": "manhole_652_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388676.42436970770359, 5861588.255991329438984 ], [ 1388632.324464634526521, 5861606.441272142343223 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E26", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 898.4000244140625, "invlev_up": 897.70001220703125, "invlev_dn": 895.9000244140625, "manhole_up": "manhole_652_generated", "manhole_dn": "manhole_653_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388632.324464634526521, 5861606.441272142343223 ], [ 1388583.463808472501114, 5861611.105615227483213 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E27", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 898.4000244140625, "elevtn_dn": 898.4000244140625, "invlev_up": 895.9000244140625, "invlev_dn": 895.9000244140625, "manhole_up": "manhole_653_generated", "manhole_dn": "manhole_654_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388583.463808472501114, 5861611.105615227483213 ], [ 1388534.764012826373801, 5861604.222017968073487 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E28", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 898.4000244140625, "elevtn_dn": 903.60003662109375, "invlev_up": 895.9000244140625, "invlev_dn": 901.10003662109375, "manhole_up": "manhole_654_generated", "manhole_dn": "manhole_655_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388534.764012826373801, 5861604.222017968073487 ], [ 1388489.566489090910181, 5861583.40731808822602 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E29", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 903.60003662109375, "elevtn_dn": 903.60003662109375, "invlev_up": 901.10003662109375, "invlev_dn": 901.10003662109375, "manhole_up": "manhole_655_generated", "manhole_dn": "manhole_656_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388489.566489090910181, 5861583.40731808822602 ], [ 1388444.204915680922568, 5861563.162508152425289 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E30", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 903.60003662109375, "elevtn_dn": 906.4000244140625, "invlev_up": 901.10003662109375, "invlev_dn": 903.9000244140625, "manhole_up": "manhole_656_generated", "manhole_dn": "manhole_657_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388444.204915680922568, 5861563.162508152425289 ], [ 1388394.858231473481283, 5861556.761520680040121 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E31", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 906.4000244140625, "elevtn_dn": 906.4000244140625, "invlev_up": 903.9000244140625, "invlev_dn": 903.9000244140625, "manhole_up": "manhole_657_generated", "manhole_dn": "manhole_658_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388394.858231473481283, 5861556.761520680040121 ], [ 1388350.680838279658929, 5861570.408674017526209 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E32", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 906.4000244140625, "elevtn_dn": 900.20001220703125, "invlev_up": 903.9000244140625, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_658_generated", "manhole_dn": "manhole_659_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388350.680838279658929, 5861570.408674017526209 ], [ 1388310.581732882419601, 5861599.872713611461222 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E33", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_659_generated", "manhole_dn": "manhole_660_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388310.581732882419601, 5861599.872713611461222 ], [ 1388271.039625711739063, 5861629.969603477045894 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E34", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 890.0, "invlev_up": 897.70001220703125, "invlev_dn": 887.5, "manhole_up": "manhole_660_generated", "manhole_dn": "manhole_661_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388271.039625711739063, 5861629.969603477045894 ], [ 1388236.722210306907073, 5861666.002683873288333 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E35", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 890.0, "invlev_up": 887.5, "invlev_dn": 887.5, "manhole_up": "manhole_661_generated", "manhole_dn": "manhole_662_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388236.722210306907073, 5861666.002683873288333 ], [ 1388202.404794902307913, 5861702.035764269530773 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E36", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 890.0, "invlev_up": 887.5, "invlev_dn": 887.5, "manhole_up": "manhole_662_generated", "manhole_dn": "manhole_663_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388202.404794902307913, 5861702.035764269530773 ], [ 1388168.087379497475922, 5861738.068844665773213 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E37", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 885.9000244140625, "invlev_up": 887.5, "invlev_dn": 883.4000244140625, "manhole_up": "manhole_663_generated", "manhole_dn": "manhole_664_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388168.087379497475922, 5861738.068844665773213 ], [ 1388133.769964092643932, 5861774.101925062015653 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E38", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 885.9000244140625, "elevtn_dn": 874.0, "invlev_up": 883.4000244140625, "invlev_dn": 871.5, "manhole_up": "manhole_664_generated", "manhole_dn": "manhole_665_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388133.769964092643932, 5861774.101925062015653 ], [ 1388099.452548687811941, 5861810.13500545732677 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E39", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 874.0, "elevtn_dn": 874.0, "invlev_up": 871.5, "invlev_dn": 871.5, "manhole_up": "manhole_665_generated", "manhole_dn": "manhole_666_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388099.452548687811941, 5861810.13500545732677 ], [ 1388065.135133283212781, 5861846.16808585356921 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E40", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 874.0, "elevtn_dn": 862.20001220703125, "invlev_up": 871.5, "invlev_dn": 859.70001220703125, "manhole_up": "manhole_666_generated", "manhole_dn": "manhole_667_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388065.135133283212781, 5861846.16808585356921 ], [ 1388022.995196633273736, 5861866.899685021489859 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E41", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 862.20001220703125, "elevtn_dn": 862.20001220703125, "invlev_up": 859.70001220703125, "invlev_dn": 859.70001220703125, "manhole_up": "manhole_667_generated", "manhole_dn": "manhole_668_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388022.995196633273736, 5861866.899685021489859 ], [ 1387973.690499771386385, 5861873.616436487063766 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E42", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 862.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 859.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_668_generated", "manhole_dn": "manhole_669_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387973.690499771386385, 5861873.616436487063766 ], [ 1387924.470484273741022, 5861880.90659652557224 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E43", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_669_generated", "manhole_dn": "manhole_670_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387924.470484273741022, 5861880.90659652557224 ], [ 1387877.962616891367361, 5861896.157046243548393 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E44", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_670_generated", "manhole_dn": "manhole_671_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387877.962616891367361, 5861896.157046243548393 ], [ 1387917.070526217576116, 5861911.915829903446138 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E45", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_671_generated", "manhole_dn": "manhole_672_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387917.070526217576116, 5861911.915829903446138 ], [ 1387966.654667611001059, 5861916.096835186704993 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E46", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 846.29998779296875, "invlev_up": 856.70001220703125, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_672_generated", "manhole_dn": "manhole_673_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387966.654667611001059, 5861916.096835186704993 ], [ 1388016.318005530629307, 5861919.063731476664543 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E47", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 850.10003662109375, "invlev_up": 843.79998779296875, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_673_generated", "manhole_dn": "manhole_674_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388016.318005530629307, 5861919.063731476664543 ], [ 1388066.025120510486886, 5861921.359510923735797 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E48", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 850.10003662109375, "invlev_up": 847.60003662109375, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_674_generated", "manhole_dn": "manhole_675_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388066.025120510486886, 5861921.359510923735797 ], [ 1388115.732235490344465, 5861923.655290370807052 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E49", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 849.0, "invlev_up": 847.60003662109375, "invlev_dn": 846.5, "manhole_up": "manhole_675_generated", "manhole_dn": "manhole_676_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388115.732235490344465, 5861923.655290370807052 ], [ 1388161.130695321131498, 5861931.457672152668238 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E50", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 849.0, "elevtn_dn": 850.10003662109375, "invlev_up": 846.5, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_676_generated", "manhole_dn": "manhole_677_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388161.130695321131498, 5861931.457672152668238 ], [ 1388139.871223766123876, 5861964.082641129381955 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E51", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 850.10003662109375, "invlev_up": 847.60003662109375, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_677_generated", "manhole_dn": "manhole_678_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388139.871223766123876, 5861964.082641129381955 ], [ 1388090.726845995755866, 5861957.769498392008245 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E52", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 846.29998779296875, "invlev_up": 847.60003662109375, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_678_generated", "manhole_dn": "manhole_679_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388090.726845995755866, 5861957.769498392008245 ], [ 1388049.339104855433106, 5861983.736727176234126 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E53", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 846.29998779296875, "invlev_up": 843.79998779296875, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_679_generated", "manhole_dn": "manhole_680_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388049.339104855433106, 5861983.736727176234126 ], [ 1388024.713075590552762, 5862026.975905770435929 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E54", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 846.29998779296875, "invlev_up": 843.79998779296875, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_680_generated", "manhole_dn": "manhole_681_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388024.713075590552762, 5862026.975905770435929 ], [ 1387980.016218039905652, 5862047.702198376879096 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E55", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 793.5, "invlev_up": 843.79998779296875, "invlev_dn": 791.0, "manhole_up": "manhole_681_generated", "manhole_dn": "manhole_682_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387980.016218039905652, 5862047.702198376879096 ], [ 1387931.90673128189519, 5862056.853296543471515 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E56", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.5, "elevtn_dn": 793.5, "invlev_up": 791.0, "invlev_dn": 791.0, "manhole_up": "manhole_682_generated", "manhole_dn": "manhole_683_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387931.90673128189519, 5862056.853296543471515 ], [ 1387882.187313467729837, 5862058.865105460397899 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E57", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.5, "elevtn_dn": 793.20001220703125, "invlev_up": 791.0, "invlev_dn": 790.70001220703125, "manhole_up": "manhole_683_generated", "manhole_dn": "manhole_684_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387882.187313467729837, 5862058.865105460397899 ], [ 1387832.722497318405658, 5862057.3410848621279 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E58", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.20001220703125, "elevtn_dn": 830.29998779296875, "invlev_up": 790.70001220703125, "invlev_dn": 827.79998779296875, "manhole_up": "manhole_684_generated", "manhole_dn": "manhole_685_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387832.722497318405658, 5862057.3410848621279 ], [ 1387783.80423084856011, 5862048.226750630885363 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E59", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 830.29998779296875, "elevtn_dn": 817.70001220703125, "invlev_up": 827.79998779296875, "invlev_dn": 815.20001220703125, "manhole_up": "manhole_685_generated", "manhole_dn": "manhole_686_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387783.80423084856011, 5862048.226750630885363 ], [ 1387734.885964378714561, 5862039.112416399642825 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E60", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 817.70001220703125, "elevtn_dn": 813.70001220703125, "invlev_up": 815.20001220703125, "invlev_dn": 811.20001220703125, "manhole_up": "manhole_686_generated", "manhole_dn": "manhole_687_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387734.885964378714561, 5862039.112416399642825 ], [ 1387685.967697908869013, 5862029.998082168400288 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E61", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 813.70001220703125, "elevtn_dn": 813.70001220703125, "invlev_up": 811.20001220703125, "invlev_dn": 811.20001220703125, "manhole_up": "manhole_687_generated", "manhole_dn": "manhole_688_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387685.967697908869013, 5862029.998082168400288 ], [ 1387637.036115845199674, 5862020.957140567712486 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E62", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 813.70001220703125, "elevtn_dn": 807.0, "invlev_up": 811.20001220703125, "invlev_dn": 804.5, "manhole_up": "manhole_688_generated", "manhole_dn": "manhole_689_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387637.036115845199674, 5862020.957140567712486 ], [ 1387588.033849656581879, 5862012.305794355459511 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E63", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.0, "elevtn_dn": 807.0, "invlev_up": 804.5, "invlev_dn": 804.5, "manhole_up": "manhole_689_generated", "manhole_dn": "manhole_690_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387588.033849656581879, 5862012.305794355459511 ], [ 1387539.031583468196914, 5862003.654448143206537 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E64", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.0, "elevtn_dn": 793.10003662109375, "invlev_up": 804.5, "invlev_dn": 790.60003662109375, "manhole_up": "manhole_690_generated", "manhole_dn": "manhole_691_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387539.031583468196914, 5862003.654448143206537 ], [ 1387490.029317279579118, 5861995.003101930953562 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E65", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.10003662109375, "elevtn_dn": 793.10003662109375, "invlev_up": 790.60003662109375, "invlev_dn": 790.60003662109375, "manhole_up": "manhole_691_generated", "manhole_dn": "manhole_692_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387490.029317279579118, 5861995.003101930953562 ], [ 1387440.720367865404114, 5861989.908138634636998 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E66", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.10003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 790.60003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_692_generated", "manhole_dn": "manhole_693_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387440.720367865404114, 5861989.908138634636998 ], [ 1387390.960446665296331, 5861990.042768024839461 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E67", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_693_generated", "manhole_dn": "manhole_694_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387390.960446665296331, 5861990.042768024839461 ], [ 1387341.200525465421379, 5861990.177397414110601 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E68", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 749.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 747.10003662109375, "manhole_up": "manhole_694_generated", "manhole_dn": "manhole_695_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387341.200525465421379, 5861990.177397414110601 ], [ 1387291.440604265546426, 5861990.312026804313064 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E69", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 749.60003662109375, "elevtn_dn": 749.60003662109375, "invlev_up": 747.10003662109375, "invlev_dn": 747.10003662109375, "manhole_up": "manhole_695_generated", "manhole_dn": "manhole_696_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387291.440604265546426, 5861990.312026804313064 ], [ 1387246.706285298336297, 5861974.212805554270744 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E70", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 749.60003662109375, "elevtn_dn": 747.0, "invlev_up": 747.10003662109375, "invlev_dn": 744.5, "manhole_up": "manhole_696_generated", "manhole_dn": "manhole_697_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387246.706285298336297, 5861974.212805554270744 ], [ 1387205.725988702848554, 5861945.987228964455426 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E71", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.0, "elevtn_dn": 771.79998779296875, "invlev_up": 744.5, "invlev_dn": 769.29998779296875, "manhole_up": "manhole_697_generated", "manhole_dn": "manhole_698_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387205.725988702848554, 5861945.987228964455426 ], [ 1387164.745692107127979, 5861917.761652374640107 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E72", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.79998779296875, "elevtn_dn": 764.10003662109375, "invlev_up": 769.29998779296875, "invlev_dn": 761.60003662109375, "manhole_up": "manhole_698_generated", "manhole_dn": "manhole_699_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387164.745692107127979, 5861917.761652374640107 ], [ 1387115.569933785125613, 5861911.215812381356955 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E73", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 764.10003662109375, "elevtn_dn": 764.10003662109375, "invlev_up": 761.60003662109375, "invlev_dn": 761.60003662109375, "manhole_up": "manhole_699_generated", "manhole_dn": "manhole_700_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387115.569933785125613, 5861911.215812381356955 ], [ 1387066.165866439929232, 5861905.273926095105708 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E74", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 764.10003662109375, "elevtn_dn": 747.70001220703125, "invlev_up": 761.60003662109375, "invlev_dn": 745.20001220703125, "manhole_up": "manhole_700_generated", "manhole_dn": "manhole_701_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387066.165866439929232, 5861905.273926095105708 ], [ 1387016.666836149292067, 5861900.238133460283279 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E75", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.70001220703125, "elevtn_dn": 747.70001220703125, "invlev_up": 745.20001220703125, "invlev_dn": 745.20001220703125, "manhole_up": "manhole_701_generated", "manhole_dn": "manhole_702_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387016.666836149292067, 5861900.238133460283279 ], [ 1386975.698310127714649, 5861874.842493440955877 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E76", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.70001220703125, "elevtn_dn": 739.60003662109375, "invlev_up": 745.20001220703125, "invlev_dn": 737.10003662109375, "manhole_up": "manhole_702_generated", "manhole_dn": "manhole_703_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386975.698310127714649, 5861874.842493440955877 ], [ 1386937.286019780673087, 5861843.21080310922116 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E77", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 739.60003662109375, "elevtn_dn": 739.60003662109375, "invlev_up": 737.10003662109375, "invlev_dn": 737.10003662109375, "manhole_up": "manhole_703_generated", "manhole_dn": "manhole_704_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386937.286019780673087, 5861843.21080310922116 ], [ 1386898.873729433864355, 5861811.579112778417766 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E78", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 739.60003662109375, "elevtn_dn": 755.20001220703125, "invlev_up": 737.10003662109375, "invlev_dn": 752.70001220703125, "manhole_up": "manhole_704_generated", "manhole_dn": "manhole_705_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386898.873729433864355, 5861811.579112778417766 ], [ 1386860.461439087055624, 5861779.947422447614372 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E79", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.20001220703125, "elevtn_dn": 745.29998779296875, "invlev_up": 752.70001220703125, "invlev_dn": 742.79998779296875, "manhole_up": "manhole_705_generated", "manhole_dn": "manhole_706_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386860.461439087055624, 5861779.947422447614372 ], [ 1386822.049148740014061, 5861748.315732115879655 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E80", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 745.29998779296875, "elevtn_dn": 745.29998779296875, "invlev_up": 742.79998779296875, "invlev_dn": 742.79998779296875, "manhole_up": "manhole_706_generated", "manhole_dn": "manhole_707_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386822.049148740014061, 5861748.315732115879655 ], [ 1386774.418702265014872, 5861733.958941764198244 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E81", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 745.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 742.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_707_generated", "manhole_dn": "manhole_708_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386774.418702265014872, 5861733.958941764198244 ], [ 1386726.75721522886306, 5861719.660321676172316 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E82", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_708_generated", "manhole_dn": "manhole_709_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386726.75721522886306, 5861719.660321676172316 ], [ 1386681.211287560872734, 5861700.510515534318984 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E83", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 777.9000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_709_generated", "manhole_dn": "manhole_710_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386681.211287560872734, 5861700.510515534318984 ], [ 1386655.081909105414525, 5861659.807657876051962 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E84", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 758.79998779296875, "invlev_up": 775.4000244140625, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_710_generated", "manhole_dn": "manhole_711_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386655.081909105414525, 5861659.807657876051962 ], [ 1386647.41175345890224, 5861610.757949161343277 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E85", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_711_generated", "manhole_dn": "manhole_712_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386647.41175345890224, 5861610.757949161343277 ], [ 1386641.745189253240824, 5861561.363539570011199 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E86", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 732.4000244140625, "invlev_up": 756.29998779296875, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_712_generated", "manhole_dn": "manhole_713_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386641.745189253240824, 5861561.363539570011199 ], [ 1386642.37134926696308, 5861511.607376066967845 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E87", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_713_generated", "manhole_dn": "manhole_714_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386642.37134926696308, 5861511.607376066967845 ], [ 1386642.997509280918166, 5861461.851212563924491 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E88", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_714_generated", "manhole_dn": "manhole_715_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386642.997509280918166, 5861461.851212563924491 ], [ 1386643.623669294640422, 5861412.09504906181246 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E89", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 724.29998779296875, "invlev_up": 729.9000244140625, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_715_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386643.623669294640422, 5861412.09504906181246 ], [ 1386648.271799877518788, 5861347.644815167412162 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_35_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_35", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_35", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_716_generated", "manhole_dn": "manhole_717_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386060.978602184914052, 5859873.390328846871853 ], [ 1386078.54455375042744, 5859857.065600479952991 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_35_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_35", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_35", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_717_generated", "manhole_dn": "manhole_718_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386078.54455375042744, 5859857.065600479952991 ], [ 1386079.86695942771621, 5859885.500408614054322 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_36_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_36", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_36", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_719_generated", "manhole_dn": "manhole_716_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386030.926458492642269, 5859869.881591100245714 ], [ 1386060.978602184914052, 5859873.390328846871853 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_37_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_37", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_37", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_720_generated", "manhole_dn": "manhole_716_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386043.381105761509389, 5859908.11929196305573 ], [ 1386060.978602184914052, 5859873.390328846871853 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_38_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_38", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_718_generated", "manhole_dn": "manhole_721_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386079.86695942771621, 5859885.500408614054322 ], [ 1386081.40363402524963, 5859934.756705570034683 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_38_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_38", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_721_generated", "manhole_dn": "manhole_722_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386081.40363402524963, 5859934.756705570034683 ], [ 1386080.471781946951523, 5859983.948014200665057 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_38_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_38", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 756.5, "invlev_up": 763.79998779296875, "invlev_dn": 754.0, "manhole_up": "manhole_722_generated", "manhole_dn": "manhole_723_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386080.471781946951523, 5859983.948014200665057 ], [ 1386081.101269942475483, 5860033.01989212166518 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_39_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_39", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_718_generated", "manhole_dn": "manhole_724_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386079.86695942771621, 5859885.500408614054322 ], [ 1386051.415038994979113, 5859913.714703594334424 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_39_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_39", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_724_generated", "manhole_dn": "manhole_725_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386051.415038994979113, 5859913.714703594334424 ], [ 1386056.753747603856027, 5859949.43277302198112 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_39_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_39", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_725_generated", "manhole_dn": "manhole_726_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386056.753747603856027, 5859949.43277302198112 ], [ 1386070.153564189793542, 5859990.873222404159606 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_39_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_39", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 756.5, "invlev_up": 763.79998779296875, "invlev_dn": 754.0, "manhole_up": "manhole_726_generated", "manhole_dn": "manhole_723_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386070.153564189793542, 5859990.873222404159606 ], [ 1386081.101269942475483, 5860033.01989212166518 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.5, "elevtn_dn": 756.5, "invlev_up": 754.0, "invlev_dn": 754.0, "manhole_up": "manhole_723_generated", "manhole_dn": "manhole_727_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386081.101269942475483, 5860033.01989212166518 ], [ 1386095.159510504920036, 5860079.476792480796576 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.5, "elevtn_dn": 720.29998779296875, "invlev_up": 754.0, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_727_generated", "manhole_dn": "manhole_728_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386095.159510504920036, 5860079.476792480796576 ], [ 1386119.249574675457552, 5860122.285581497475505 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_728_generated", "manhole_dn": "manhole_729_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386119.249574675457552, 5860122.285581497475505 ], [ 1386143.813145637512207, 5860164.822058788500726 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 732.5, "invlev_up": 717.79998779296875, "invlev_dn": 730.0, "manhole_up": "manhole_729_generated", "manhole_dn": "manhole_730_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386143.813145637512207, 5860164.822058788500726 ], [ 1386168.698389830067754, 5860207.173543182201684 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.5, "elevtn_dn": 732.5, "invlev_up": 730.0, "invlev_dn": 730.0, "manhole_up": "manhole_730_generated", "manhole_dn": "manhole_731_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386168.698389830067754, 5860207.173543182201684 ], [ 1386190.960878706537187, 5860250.914158629253507 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.5, "elevtn_dn": 720.29998779296875, "invlev_up": 730.0, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_731_generated", "manhole_dn": "manhole_732_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386190.960878706537187, 5860250.914158629253507 ], [ 1386212.013376480899751, 5860295.295640649273992 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 729.10003662109375, "invlev_up": 717.79998779296875, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_732_generated", "manhole_dn": "manhole_733_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386212.013376480899751, 5860295.295640649273992 ], [ 1386233.065874255495146, 5860339.677122670225799 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 729.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_733_generated", "manhole_dn": "manhole_734_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386233.065874255495146, 5860339.677122670225799 ], [ 1386254.118372030090541, 5860384.058604690246284 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E8", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 729.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_734_generated", "manhole_dn": "manhole_735_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386254.118372030090541, 5860384.058604690246284 ], [ 1386270.265550139825791, 5860430.368606903590262 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E9", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 746.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 743.60003662109375, "manhole_up": "manhole_735_generated", "manhole_dn": "manhole_736_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386270.265550139825791, 5860430.368606903590262 ], [ 1386284.690116602927446, 5860477.310510716401041 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E10", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 746.10003662109375, "elevtn_dn": 746.10003662109375, "invlev_up": 743.60003662109375, "invlev_dn": 743.60003662109375, "manhole_up": "manhole_736_generated", "manhole_dn": "manhole_737_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386284.690116602927446, 5860477.310510716401041 ], [ 1386295.943752367515117, 5860525.125563691370189 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E11", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 746.10003662109375, "elevtn_dn": 720.29998779296875, "invlev_up": 743.60003662109375, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_737_generated", "manhole_dn": "manhole_738_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386295.943752367515117, 5860525.125563691370189 ], [ 1386307.197388132335618, 5860572.940616665408015 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E12", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_738_generated", "manhole_dn": "manhole_739_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386307.197388132335618, 5860572.940616665408015 ], [ 1386318.451023896923289, 5860620.755669640377164 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E13", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_739_generated", "manhole_dn": "manhole_740_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386318.451023896923289, 5860620.755669640377164 ], [ 1386329.704659661510959, 5860668.57072261441499 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E14", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 737.60003662109375, "invlev_up": 717.79998779296875, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_740_generated", "manhole_dn": "manhole_741_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386329.704659661510959, 5860668.57072261441499 ], [ 1386340.95829542633146, 5860716.385775589384139 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E15", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 737.60003662109375, "invlev_up": 735.10003662109375, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_741_generated", "manhole_dn": "manhole_742_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386340.95829542633146, 5860716.385775589384139 ], [ 1386352.211931190919131, 5860764.200828563421965 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E16", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 737.60003662109375, "invlev_up": 735.10003662109375, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_742_generated", "manhole_dn": "manhole_743_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386352.211931190919131, 5860764.200828563421965 ], [ 1386365.771370212780312, 5860811.365820310078561 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E17", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 744.5, "invlev_up": 735.10003662109375, "invlev_dn": 742.0, "manhole_up": "manhole_743_generated", "manhole_dn": "manhole_744_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386365.771370212780312, 5860811.365820310078561 ], [ 1386381.150273493025452, 5860858.017861452884972 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E18", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 744.5, "elevtn_dn": 724.29998779296875, "invlev_up": 742.0, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_744_generated", "manhole_dn": "manhole_745_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386381.150273493025452, 5860858.017861452884972 ], [ 1386398.399082327727228, 5860903.951519219204783 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E19", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_745_generated", "manhole_dn": "manhole_746_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386398.399082327727228, 5860903.951519219204783 ], [ 1386418.211523674428463, 5860948.90027645137161 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E20", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_746_generated", "manhole_dn": "manhole_747_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386418.211523674428463, 5860948.90027645137161 ], [ 1386441.67837643600069, 5860992.033180211670697 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E21", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_747_generated", "manhole_dn": "manhole_748_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386441.67837643600069, 5860992.033180211670697 ], [ 1386465.536530936835334, 5861034.971648660488427 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E22", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.9000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 722.4000244140625, "manhole_up": "manhole_748_generated", "manhole_dn": "manhole_749_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386465.536530936835334, 5861034.971648660488427 ], [ 1386489.394685437437147, 5861077.910117109306157 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E23", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.9000244140625, "elevtn_dn": 724.29998779296875, "invlev_up": 722.4000244140625, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_749_generated", "manhole_dn": "manhole_750_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386489.394685437437147, 5861077.910117109306157 ], [ 1386513.252839938271791, 5861120.848585557192564 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E24", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_750_generated", "manhole_dn": "manhole_751_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386513.252839938271791, 5861120.848585557192564 ], [ 1386537.110994438873604, 5861163.787054006010294 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E25", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_751_generated", "manhole_dn": "manhole_752_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386537.110994438873604, 5861163.787054006010294 ], [ 1386560.969148939708248, 5861206.725522454828024 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E26", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_752_generated", "manhole_dn": "manhole_753_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386560.969148939708248, 5861206.725522454828024 ], [ 1386584.827303440310061, 5861249.663990902714431 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E27", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_753_generated", "manhole_dn": "manhole_754_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386584.827303440310061, 5861249.663990902714431 ], [ 1386607.696082097478211, 5861293.105181481689215 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E28", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_754_generated", "manhole_dn": "manhole_755_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386607.696082097478211, 5861293.105181481689215 ], [ 1386626.999141034670174, 5861338.164890616200864 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E29", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 732.4000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_755_generated", "manhole_dn": "manhole_756_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386626.999141034670174, 5861338.164890616200864 ], [ 1386632.635544582502916, 5861386.242180755361915 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E30", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_756_generated", "manhole_dn": "manhole_757_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386632.635544582502916, 5861386.242180755361915 ], [ 1386628.332881111185998, 5861435.174896763637662 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E31", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_757_generated", "manhole_dn": "manhole_758_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386628.332881111185998, 5861435.174896763637662 ], [ 1386624.030217639869079, 5861484.107612771913409 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E32", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 758.79998779296875, "invlev_up": 729.9000244140625, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_758_generated", "manhole_dn": "manhole_759_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386624.030217639869079, 5861484.107612771913409 ], [ 1386619.72755416855216, 5861533.040328779257834 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E33", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_759_generated", "manhole_dn": "manhole_760_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386619.72755416855216, 5861533.040328779257834 ], [ 1386620.396809899713844, 5861581.843449912965298 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E34", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_760_generated", "manhole_dn": "manhole_761_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386620.396809899713844, 5861581.843449912965298 ], [ 1386627.242796876933426, 5861630.485572309233248 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E35", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 777.9000244140625, "invlev_up": 756.29998779296875, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_761_generated", "manhole_dn": "manhole_762_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386627.242796876933426, 5861630.485572309233248 ], [ 1386633.497009602142498, 5861679.177458625286818 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E36", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 777.9000244140625, "invlev_up": 775.4000244140625, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_762_generated", "manhole_dn": "manhole_763_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386633.497009602142498, 5861679.177458625286818 ], [ 1386633.587326586712152, 5861728.232037586160004 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E37", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 777.9000244140625, "invlev_up": 775.4000244140625, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_763_generated", "manhole_dn": "manhole_764_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386633.587326586712152, 5861728.232037586160004 ], [ 1386628.569951781770214, 5861777.096641942858696 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E38", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 787.0, "invlev_up": 775.4000244140625, "invlev_dn": 784.5, "manhole_up": "manhole_764_generated", "manhole_dn": "manhole_765_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386628.569951781770214, 5861777.096641942858696 ], [ 1386623.552576976828277, 5861825.961246299557388 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 787.0, "elevtn_dn": 787.0, "invlev_up": 784.5, "invlev_dn": 784.5, "manhole_up": "manhole_765_generated", "manhole_dn": "manhole_766_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386623.552576976828277, 5861825.961246299557388 ], [ 1386622.452884682221338, 5861875.377415779046714 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 787.0, "elevtn_dn": 768.0, "invlev_up": 784.5, "invlev_dn": 765.5, "manhole_up": "manhole_766_generated", "manhole_dn": "manhole_767_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386622.452884682221338, 5861875.377415779046714 ], [ 1386630.050831846194342, 5861924.208797036670148 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_767_generated", "manhole_dn": "manhole_768_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386630.050831846194342, 5861924.208797036670148 ], [ 1386645.112437101313844, 5861971.295391816645861 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_768_generated", "manhole_dn": "manhole_769_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386645.112437101313844, 5861971.295391816645861 ], [ 1386663.826805545249954, 5862017.116109635680914 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 729.0, "invlev_up": 765.5, "invlev_dn": 726.5, "manhole_up": "manhole_769_generated", "manhole_dn": "manhole_770_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386663.826805545249954, 5862017.116109635680914 ], [ 1386682.541173989186063, 5862062.93682745564729 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 729.0, "invlev_up": 726.5, "invlev_dn": 726.5, "manhole_up": "manhole_770_generated", "manhole_dn": "manhole_771_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386682.541173989186063, 5862062.93682745564729 ], [ 1386700.357504795538262, 5862109.113540357910097 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 729.0, "invlev_up": 726.5, "invlev_dn": 726.5, "manhole_up": "manhole_771_generated", "manhole_dn": "manhole_772_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386700.357504795538262, 5862109.113540357910097 ], [ 1386718.120609947945923, 5862155.311352676711977 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 724.29998779296875, "invlev_up": 726.5, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_772_generated", "manhole_dn": "manhole_773_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386718.120609947945923, 5862155.311352676711977 ], [ 1386735.883715100120753, 5862201.509164996445179 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E8", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_773_generated", "manhole_dn": "manhole_774_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386735.883715100120753, 5862201.509164996445179 ], [ 1386757.522535112220794, 5862245.993861058726907 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E9", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_774_generated", "manhole_dn": "manhole_775_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386757.522535112220794, 5862245.993861058726907 ], [ 1386779.73098383564502, 5862290.226773838512599 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E10", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_775_generated", "manhole_dn": "manhole_776_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386779.73098383564502, 5862290.226773838512599 ], [ 1386802.545179207576439, 5862334.095372994430363 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E11", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_776_generated", "manhole_dn": "manhole_777_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386802.545179207576439, 5862334.095372994430363 ], [ 1386831.207993831252679, 5862374.446442689746618 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E12", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 737.70001220703125, "invlev_up": 721.79998779296875, "invlev_dn": 735.20001220703125, "manhole_up": "manhole_777_generated", "manhole_dn": "manhole_778_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386831.207993831252679, 5862374.446442689746618 ], [ 1386859.988485741894692, 5862414.708453865721822 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E13", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.70001220703125, "elevtn_dn": 737.70001220703125, "invlev_up": 735.20001220703125, "invlev_dn": 735.20001220703125, "manhole_up": "manhole_778_generated", "manhole_dn": "manhole_779_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386859.988485741894692, 5862414.708453865721822 ], [ 1386891.035651177866384, 5862453.255039785988629 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E14", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.70001220703125, "elevtn_dn": 743.9000244140625, "invlev_up": 735.20001220703125, "invlev_dn": 741.4000244140625, "manhole_up": "manhole_779_generated", "manhole_dn": "manhole_780_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386891.035651177866384, 5862453.255039785988629 ], [ 1386922.082816614070907, 5862491.801625707186759 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E15", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 743.9000244140625, "elevtn_dn": 756.0, "invlev_up": 741.4000244140625, "invlev_dn": 753.5, "manhole_up": "manhole_780_generated", "manhole_dn": "manhole_781_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386922.082816614070907, 5862491.801625707186759 ], [ 1386953.12998205027543, 5862530.348211627453566 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E16", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.0, "elevtn_dn": 756.0, "invlev_up": 753.5, "invlev_dn": 753.5, "manhole_up": "manhole_781_generated", "manhole_dn": "manhole_782_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386953.12998205027543, 5862530.348211627453566 ], [ 1386984.177147486479953, 5862568.894797547720373 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E17", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.0, "elevtn_dn": 761.4000244140625, "invlev_up": 753.5, "invlev_dn": 758.9000244140625, "manhole_up": "manhole_782_generated", "manhole_dn": "manhole_783_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386984.177147486479953, 5862568.894797547720373 ], [ 1387010.83190148579888, 5862610.297833287157118 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E18", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.4000244140625, "elevtn_dn": 761.4000244140625, "invlev_up": 758.9000244140625, "invlev_dn": 758.9000244140625, "manhole_up": "manhole_783_generated", "manhole_dn": "manhole_784_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387010.83190148579888, 5862610.297833287157118 ], [ 1387033.474099110113457, 5862654.310293504968286 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E19", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.4000244140625, "elevtn_dn": 770.5, "invlev_up": 758.9000244140625, "invlev_dn": 768.0, "manhole_up": "manhole_784_generated", "manhole_dn": "manhole_785_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387033.474099110113457, 5862654.310293504968286 ], [ 1387056.116296734428033, 5862698.322753723710775 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E20", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 770.5, "elevtn_dn": 765.29998779296875, "invlev_up": 768.0, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_785_generated", "manhole_dn": "manhole_786_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387056.116296734428033, 5862698.322753723710775 ], [ 1387078.75849435874261, 5862742.335213942453265 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E21", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 765.29998779296875, "invlev_up": 762.79998779296875, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_786_generated", "manhole_dn": "manhole_787_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387078.75849435874261, 5862742.335213942453265 ], [ 1387101.400691983057186, 5862786.347674161195755 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E22", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 765.29998779296875, "invlev_up": 762.79998779296875, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_787_generated", "manhole_dn": "manhole_788_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387101.400691983057186, 5862786.347674161195755 ], [ 1387124.783531384309754, 5862829.966971693560481 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E23", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 764.20001220703125, "invlev_up": 762.79998779296875, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_788_generated", "manhole_dn": "manhole_789_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387124.783531384309754, 5862829.966971693560481 ], [ 1387148.551342260092497, 5862873.381910757161677 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E24", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 764.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_789_generated", "manhole_dn": "manhole_790_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387148.551342260092497, 5862873.381910757161677 ], [ 1387176.029596295906231, 5862914.516764627769589 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E25", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 764.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_790_generated", "manhole_dn": "manhole_791_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387176.029596295906231, 5862914.516764627769589 ], [ 1387204.050833505578339, 5862955.315435893833637 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E26", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 769.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 766.70001220703125, "manhole_up": "manhole_791_generated", "manhole_dn": "manhole_792_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387204.050833505578339, 5862955.315435893833637 ], [ 1387233.152246462181211, 5862995.351338926702738 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E27", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 769.20001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 766.70001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_792_generated", "manhole_dn": "manhole_793_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387233.152246462181211, 5862995.351338926702738 ], [ 1387262.253659419016913, 5863035.387241959571838 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E28", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 770.20001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_793_generated", "manhole_dn": "manhole_794_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387262.253659419016913, 5863035.387241959571838 ], [ 1387289.177211825968698, 5863076.714860137552023 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E29", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 770.20001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_794_generated", "manhole_dn": "manhole_795_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387289.177211825968698, 5863076.714860137552023 ], [ 1387304.666786204557866, 5863123.392671256326139 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E30", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 762.0, "invlev_up": 770.20001220703125, "invlev_dn": 759.5, "manhole_up": "manhole_795_generated", "manhole_dn": "manhole_796_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387304.666786204557866, 5863123.392671256326139 ], [ 1387314.520281337434426, 5863171.895173518918455 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E31", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 777.10003662109375, "invlev_up": 759.5, "invlev_dn": 774.60003662109375, "manhole_up": "manhole_796_generated", "manhole_dn": "manhole_797_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387314.520281337434426, 5863171.895173518918455 ], [ 1387324.142220750683919, 5863220.446013364940882 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E32", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.10003662109375, "elevtn_dn": 780.4000244140625, "invlev_up": 774.60003662109375, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_797_generated", "manhole_dn": "manhole_798_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387324.142220750683919, 5863220.446013364940882 ], [ 1387333.764160163700581, 5863268.996853210031986 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E33", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 780.4000244140625, "invlev_up": 777.9000244140625, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_798_generated", "manhole_dn": "manhole_799_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387333.764160163700581, 5863268.996853210031986 ], [ 1387343.386099576717243, 5863317.547693055123091 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E34", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 780.4000244140625, "invlev_up": 777.9000244140625, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_799_generated", "manhole_dn": "manhole_800_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387343.386099576717243, 5863317.547693055123091 ], [ 1387353.008038989733905, 5863366.098532900214195 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E35", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 762.0, "invlev_up": 777.9000244140625, "invlev_dn": 759.5, "manhole_up": "manhole_800_generated", "manhole_dn": "manhole_801_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387353.008038989733905, 5863366.098532900214195 ], [ 1387364.066297837067395, 5863414.311534740030766 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E36", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_801_generated", "manhole_dn": "manhole_802_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387364.066297837067395, 5863414.311534740030766 ], [ 1387381.839409928303212, 5863460.427046488039196 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E37", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_802_generated", "manhole_dn": "manhole_803_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387381.839409928303212, 5863460.427046488039196 ], [ 1387403.429578960640356, 5863504.96100580971688 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E38", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_803_generated", "manhole_dn": "manhole_804_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387403.429578960640356, 5863504.96100580971688 ], [ 1387425.140452897874638, 5863549.440256260335445 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E39", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_804_generated", "manhole_dn": "manhole_805_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387425.140452897874638, 5863549.440256260335445 ], [ 1387446.851326835108921, 5863593.91950671095401 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E40", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_805_generated", "manhole_dn": "manhole_806_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387446.851326835108921, 5863593.91950671095401 ], [ 1387467.528695637593046, 5863638.888379830867052 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E41", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 774.5, "invlev_up": 759.5, "invlev_dn": 772.0, "manhole_up": "manhole_806_generated", "manhole_dn": "manhole_807_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387467.528695637593046, 5863638.888379830867052 ], [ 1387488.196078018052503, 5863683.861984014511108 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E42", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 774.5, "elevtn_dn": 762.0, "invlev_up": 772.0, "invlev_dn": 759.5, "manhole_up": "manhole_807_generated", "manhole_dn": "manhole_808_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387488.196078018052503, 5863683.861984014511108 ], [ 1387508.863468252588063, 5863728.835584589280188 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E43", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_808_generated", "manhole_dn": "manhole_809_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387508.863468252588063, 5863728.835584589280188 ], [ 1387529.53130904212594, 5863773.808978110551834 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E44", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_809_generated", "manhole_dn": "manhole_810_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387529.53130904212594, 5863773.808978110551834 ], [ 1387553.168002701364458, 5863817.17347530182451 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E45", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_810_generated", "manhole_dn": "manhole_811_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387553.168002701364458, 5863817.17347530182451 ], [ 1387579.562712850514799, 5863859.043333718553185 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E46", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 777.0, "invlev_up": 759.5, "invlev_dn": 774.5, "manhole_up": "manhole_811_generated", "manhole_dn": "manhole_812_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387579.562712850514799, 5863859.043333718553185 ], [ 1387605.957422999665141, 5863900.913192136213183 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E47", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.0, "elevtn_dn": 762.0, "invlev_up": 774.5, "invlev_dn": 759.5, "manhole_up": "manhole_812_generated", "manhole_dn": "manhole_813_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387605.957422999665141, 5863900.913192136213183 ], [ 1387632.352133149048313, 5863942.783050553873181 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E48", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_813_generated", "manhole_dn": "manhole_814_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387632.352133149048313, 5863942.783050553873181 ], [ 1387658.746843298198655, 5863984.652908970601857 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E49", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_814_generated", "manhole_dn": "manhole_815_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387658.746843298198655, 5863984.652908970601857 ], [ 1387685.893106181640178, 5864026.029537551105022 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E50", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_815_generated", "manhole_dn": "manhole_816_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387685.893106181640178, 5864026.029537551105022 ], [ 1387711.231136992340907, 5864068.42725711222738 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E51", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_816_generated", "manhole_dn": "manhole_817_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387711.231136992340907, 5864068.42725711222738 ], [ 1387731.020947323646396, 5864113.414904261007905 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E52", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_817_generated", "manhole_dn": "manhole_818_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387731.020947323646396, 5864113.414904261007905 ], [ 1387737.361907477490604, 5864162.342261835932732 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E53", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_818_generated", "manhole_dn": "manhole_819_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387737.361907477490604, 5864162.342261835932732 ], [ 1387732.727565656881779, 5864211.475179814733565 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E54", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_819_generated", "manhole_dn": "manhole_820_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387732.727565656881779, 5864211.475179814733565 ], [ 1387717.67884943424724, 5864258.627082298509777 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E55", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_820_generated", "manhole_dn": "manhole_821_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387717.67884943424724, 5864258.627082298509777 ], [ 1387709.67210421175696, 5864307.23127611912787 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E56", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 768.0, "invlev_up": 759.5, "invlev_dn": 765.5, "manhole_up": "manhole_821_generated", "manhole_dn": "manhole_822_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387709.67210421175696, 5864307.23127611912787 ], [ 1387707.11288084089756, 5864356.66017600055784 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E57", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_822_generated", "manhole_dn": "manhole_823_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387707.11288084089756, 5864356.66017600055784 ], [ 1387709.591797993984073, 5864406.012949175201356 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E58", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_823_generated", "manhole_dn": "manhole_824_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387709.591797993984073, 5864406.012949175201356 ], [ 1387713.643261310644448, 5864455.341961052268744 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E59", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 777.20001220703125, "invlev_up": 765.5, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_824_generated", "manhole_dn": "manhole_825_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387713.643261310644448, 5864455.341961052268744 ], [ 1387715.877521668095142, 5864504.642317942343652 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E60", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 774.70001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_825_generated", "manhole_dn": "manhole_826_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387715.877521668095142, 5864504.642317942343652 ], [ 1387708.68023270717822, 5864553.426558391191065 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E61", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 774.70001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_826_generated", "manhole_dn": "manhole_827_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387708.68023270717822, 5864553.426558391191065 ], [ 1387690.790250770282, 5864599.575386263430119 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E62", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 810.60003662109375, "invlev_up": 774.70001220703125, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_827_generated", "manhole_dn": "manhole_828_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387690.790250770282, 5864599.575386263430119 ], [ 1387672.900268833618611, 5864645.724214136600494 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E63", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 810.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_828_generated", "manhole_dn": "manhole_829_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387672.900268833618611, 5864645.724214136600494 ], [ 1387659.931900478899479, 5864692.98388583958149 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E64", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 810.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_829_generated", "manhole_dn": "manhole_830_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387659.931900478899479, 5864692.98388583958149 ], [ 1387659.223570322152227, 5864742.029465307481587 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E65", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_830_generated", "manhole_dn": "manhole_831_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387659.223570322152227, 5864742.029465307481587 ], [ 1387675.926896508783102, 5864788.273513910360634 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E66", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 774.10003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 771.60003662109375, "manhole_up": "manhole_831_generated", "manhole_dn": "manhole_832_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387675.926896508783102, 5864788.273513910360634 ], [ 1387702.296291569946334, 5864830.159320239908993 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E67", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 774.10003662109375, "elevtn_dn": 774.10003662109375, "invlev_up": 771.60003662109375, "invlev_dn": 771.60003662109375, "manhole_up": "manhole_832_generated", "manhole_dn": "manhole_833_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387702.296291569946334, 5864830.159320239908993 ], [ 1387728.665686630876735, 5864872.045126569457352 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E68", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 774.10003662109375, "elevtn_dn": 782.5, "invlev_up": 771.60003662109375, "invlev_dn": 780.0, "manhole_up": "manhole_833_generated", "manhole_dn": "manhole_834_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387728.665686630876735, 5864872.045126569457352 ], [ 1387751.608185108983889, 5864915.528788692317903 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E69", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 782.5, "invlev_up": 780.0, "invlev_dn": 780.0, "manhole_up": "manhole_834_generated", "manhole_dn": "manhole_835_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387751.608185108983889, 5864915.528788692317903 ], [ 1387766.741664502769709, 5864962.653554677963257 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E70", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 782.5, "invlev_up": 780.0, "invlev_dn": 780.0, "manhole_up": "manhole_835_generated", "manhole_dn": "manhole_836_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387766.741664502769709, 5864962.653554677963257 ], [ 1387778.99191950308159, 5865010.246724016033113 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E71", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 820.20001220703125, "invlev_up": 780.0, "invlev_dn": 817.70001220703125, "manhole_up": "manhole_836_generated", "manhole_dn": "manhole_837_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387778.99191950308159, 5865010.246724016033113 ], [ 1387779.554608268430457, 5865059.738633952103555 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E72", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 820.20001220703125, "elevtn_dn": 820.20001220703125, "invlev_up": 817.70001220703125, "invlev_dn": 817.70001220703125, "manhole_up": "manhole_837_generated", "manhole_dn": "manhole_838_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387779.554608268430457, 5865059.738633952103555 ], [ 1387780.117297033779323, 5865109.230543887242675 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E73", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 820.20001220703125, "elevtn_dn": 834.60003662109375, "invlev_up": 817.70001220703125, "invlev_dn": 832.10003662109375, "manhole_up": "manhole_838_generated", "manhole_dn": "manhole_839_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387780.117297033779323, 5865109.230543887242675 ], [ 1387782.917817069217563, 5865158.566991245374084 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E74", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 834.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 832.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_839_generated", "manhole_dn": "manhole_840_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387782.917817069217563, 5865158.566991245374084 ], [ 1387789.203931836877018, 5865207.661293652839959 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E75", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_840_generated", "manhole_dn": "manhole_841_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387789.203931836877018, 5865207.661293652839959 ], [ 1387795.490046604769304, 5865256.755596060305834 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E76", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_841_generated", "manhole_dn": "manhole_842_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387795.490046604769304, 5865256.755596060305834 ], [ 1387804.549934879876673, 5865305.332479531876743 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E77", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 809.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_842_generated", "manhole_dn": "manhole_843_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387804.549934879876673, 5865305.332479531876743 ], [ 1387816.386747075244784, 5865353.391356389038265 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E78", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 809.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_843_generated", "manhole_dn": "manhole_844_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387816.386747075244784, 5865353.391356389038265 ], [ 1387828.223559270845726, 5865401.450233246199787 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E79", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 802.5, "invlev_up": 809.10003662109375, "invlev_dn": 800.0, "manhole_up": "manhole_844_generated", "manhole_dn": "manhole_845_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387828.223559270845726, 5865401.450233246199787 ], [ 1387842.96627543354407, 5865448.679594250395894 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E80", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 802.5, "invlev_up": 800.0, "invlev_dn": 800.0, "manhole_up": "manhole_845_generated", "manhole_dn": "manhole_846_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387842.96627543354407, 5865448.679594250395894 ], [ 1387858.283513206522912, 5865495.744953005574644 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E81", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 802.5, "invlev_up": 800.0, "invlev_dn": 800.0, "manhole_up": "manhole_846_generated", "manhole_dn": "manhole_847_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387858.283513206522912, 5865495.744953005574644 ], [ 1387872.788357679266483, 5865543.026506381109357 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E82", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 778.20001220703125, "invlev_up": 800.0, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_847_generated", "manhole_dn": "manhole_848_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387872.788357679266483, 5865543.026506381109357 ], [ 1387882.890574953285977, 5865591.479689701460302 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E83", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_848_generated", "manhole_dn": "manhole_849_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387882.890574953285977, 5865591.479689701460302 ], [ 1387892.992792227305472, 5865639.932873022742569 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E84", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_849_generated", "manhole_dn": "manhole_850_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387892.992792227305472, 5865639.932873022742569 ], [ 1387903.095009501324967, 5865688.386056343093514 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E85", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_850_generated", "manhole_dn": "manhole_851_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387903.095009501324967, 5865688.386056343093514 ], [ 1387913.197226775344461, 5865736.839239663444459 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_42_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 830.9000244140625, "invlev_up": 828.4000244140625, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_852_generated", "manhole_dn": "manhole_853_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387767.438602478476241, 5866395.894650792703032 ], [ 1387758.181959156645462, 5866444.388786932453513 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_42_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 830.9000244140625, "invlev_up": 828.4000244140625, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_853_generated", "manhole_dn": "manhole_854_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387758.181959156645462, 5866444.388786932453513 ], [ 1387748.925315835047513, 5866492.882923071272671 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_42_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 816.5, "invlev_up": 828.4000244140625, "invlev_dn": 814.0, "manhole_up": "manhole_854_generated", "manhole_dn": "manhole_855_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387748.925315835047513, 5866492.882923071272671 ], [ 1387739.668672513216734, 5866541.377059211023152 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_42_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.5, "elevtn_dn": 816.5, "invlev_up": 814.0, "invlev_dn": 814.0, "manhole_up": "manhole_855_generated", "manhole_dn": "manhole_856_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387739.668672513216734, 5866541.377059211023152 ], [ 1387730.412029191618785, 5866589.87119534984231 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_42_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.5, "elevtn_dn": 816.10003662109375, "invlev_up": 814.0, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_856_generated", "manhole_dn": "manhole_857_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387730.412029191618785, 5866589.87119534984231 ], [ 1387721.155385869788006, 5866638.365331489592791 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_42_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 816.10003662109375, "invlev_up": 813.60003662109375, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_857_generated", "manhole_dn": "manhole_858_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387721.155385869788006, 5866638.365331489592791 ], [ 1387711.868742506252602, 5866686.853722332976758 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_42_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 816.10003662109375, "invlev_up": 813.60003662109375, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_858_generated", "manhole_dn": "manhole_859_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387711.868742506252602, 5866686.853722332976758 ], [ 1387702.553355348296463, 5866735.336608462966979 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_42_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 802.4000244140625, "invlev_up": 813.60003662109375, "invlev_dn": 799.9000244140625, "manhole_up": "manhole_859_generated", "manhole_dn": "manhole_860_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387702.553355348296463, 5866735.336608462966979 ], [ 1387692.161796326050535, 5866783.420620376244187 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_43_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_43", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_43", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_861_generated", "manhole_dn": "manhole_862_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387809.534624515566975, 5866309.639251782558858 ], [ 1387788.486613497138023, 5866352.766951287165284 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_43_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_43", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_43", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 830.9000244140625, "invlev_up": 803.70001220703125, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_862_generated", "manhole_dn": "manhole_852_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387788.486613497138023, 5866352.766951287165284 ], [ 1387767.438602478476241, 5866395.894650792703032 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_44_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 840.10003662109375, "invlev_up": 828.4000244140625, "invlev_dn": 837.60003662109375, "manhole_up": "manhole_852_generated", "manhole_dn": "manhole_863_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387767.438602478476241, 5866395.894650792703032 ], [ 1387774.73306847945787, 5866351.644692087545991 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_44_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 840.10003662109375, "elevtn_dn": 806.20001220703125, "invlev_up": 837.60003662109375, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_863_generated", "manhole_dn": "manhole_864_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387774.73306847945787, 5866351.644692087545991 ], [ 1387787.219046234386042, 5866308.756401930935681 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_44_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_864_generated", "manhole_dn": "manhole_865_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387787.219046234386042, 5866308.756401930935681 ], [ 1387802.581935805035755, 5866266.622689731419086 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_44_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_865_generated", "manhole_dn": "manhole_866_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387802.581935805035755, 5866266.622689731419086 ], [ 1387818.989883717847988, 5866224.886323318816721 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_44_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_866_generated", "manhole_dn": "manhole_867_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387818.989883717847988, 5866224.886323318816721 ], [ 1387838.767447788733989, 5866184.784887914545834 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_44_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_867_generated", "manhole_dn": "manhole_868_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387838.767447788733989, 5866184.784887914545834 ], [ 1387862.375427621416748, 5866146.679679537191987 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_44_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 803.9000244140625, "invlev_up": 825.20001220703125, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_868_generated", "manhole_dn": "manhole_869_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387862.375427621416748, 5866146.679679537191987 ], [ 1387890.316308293025941, 5866111.904927220195532 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_44_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_869_generated", "manhole_dn": "manhole_870_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387890.316308293025941, 5866111.904927220195532 ], [ 1387932.086585889104754, 5866099.149365295656025 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_45_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_45", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_871_generated", "manhole_dn": "manhole_872_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387931.614702571649104, 5866170.542120457626879 ], [ 1387899.497387683717534, 5866203.806988564319909 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_45_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_45", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 806.20001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_872_generated", "manhole_dn": "manhole_873_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387899.497387683717534, 5866203.806988564319909 ], [ 1387869.509799961000681, 5866239.084409636445343 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_45_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_45", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_873_generated", "manhole_dn": "manhole_874_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387869.509799961000681, 5866239.084409636445343 ], [ 1387839.522212238283828, 5866274.361830709502101 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_45_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_45", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_874_generated", "manhole_dn": "manhole_861_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387839.522212238283828, 5866274.361830709502101 ], [ 1387809.534624515566975, 5866309.639251782558858 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_46_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_46", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_870_generated", "manhole_dn": "manhole_875_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387932.086585889104754, 5866099.149365295656025 ], [ 1387908.367353544337675, 5866141.903963415883482 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_46_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_46", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_875_generated", "manhole_dn": "manhole_876_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387908.367353544337675, 5866141.903963415883482 ], [ 1387876.955022902460769, 5866179.987773489207029 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_46_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_46", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 827.70001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_876_generated", "manhole_dn": "manhole_877_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387876.955022902460769, 5866179.987773489207029 ], [ 1387847.458594153402373, 5866219.470102892257273 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_46_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_46", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_877_generated", "manhole_dn": "manhole_878_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387847.458594153402373, 5866219.470102892257273 ], [ 1387823.639855962945148, 5866262.662997540086508 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_46_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_46", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_878_generated", "manhole_dn": "manhole_861_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387823.639855962945148, 5866262.662997540086508 ], [ 1387809.534624515566975, 5866309.639251782558858 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_47_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_47", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_879_generated", "manhole_dn": "manhole_880_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.443674022099003, 5865845.093254727311432 ], [ 1387943.318034203490242, 5865887.628139751963317 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_47_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_47", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_880_generated", "manhole_dn": "manhole_881_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387943.318034203490242, 5865887.628139751963317 ], [ 1387946.009428307646886, 5865930.175072746351361 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_47_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_47", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 816.70001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_881_generated", "manhole_dn": "manhole_882_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387946.009428307646886, 5865930.175072746351361 ], [ 1387948.700822412036359, 5865972.722005739808083 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_47_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_47", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_882_generated", "manhole_dn": "manhole_883_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387948.700822412036359, 5865972.722005739808083 ], [ 1387944.872250664513558, 5866015.105105520226061 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_47_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_47", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_883_generated", "manhole_dn": "manhole_884_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387944.872250664513558, 5866015.105105520226061 ], [ 1387940.047370131826028, 5866057.463170127011836 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_47_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_47", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 803.9000244140625, "invlev_up": 814.20001220703125, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_884_generated", "manhole_dn": "manhole_870_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.047370131826028, 5866057.463170127011836 ], [ 1387932.086585889104754, 5866099.149365295656025 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_48_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_48", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_48", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 786.29998779296875, "invlev_up": 801.4000244140625, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_870_generated", "manhole_dn": "manhole_885_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387932.086585889104754, 5866099.149365295656025 ], [ 1387975.279995472636074, 5866107.425722245126963 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E125", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 909.5, "elevtn_dn": 910.4000244140625, "invlev_up": 907.0, "invlev_dn": 907.9000244140625, "manhole_up": "manhole_886_generated", "manhole_dn": "manhole_887_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392926.966794768813998, 5866808.501405037939548 ], [ 1392879.417931769276038, 5866793.491589142940938 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E126", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 910.4000244140625, "elevtn_dn": 910.4000244140625, "invlev_up": 907.9000244140625, "invlev_dn": 907.9000244140625, "manhole_up": "manhole_887_generated", "manhole_dn": "manhole_888_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392879.417931769276038, 5866793.491589142940938 ], [ 1392831.869068769738078, 5866778.481773247942328 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E127", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 910.4000244140625, "elevtn_dn": 865.0, "invlev_up": 907.9000244140625, "invlev_dn": 862.5, "manhole_up": "manhole_888_generated", "manhole_dn": "manhole_889_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392831.869068769738078, 5866778.481773247942328 ], [ 1392784.320205770200118, 5866763.471957352943718 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E128", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 865.0, "elevtn_dn": 865.0, "invlev_up": 862.5, "invlev_dn": 862.5, "manhole_up": "manhole_889_generated", "manhole_dn": "manhole_890_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392784.320205770200118, 5866763.471957352943718 ], [ 1392736.771342770429328, 5866748.462141457945108 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E129", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 865.0, "elevtn_dn": 878.4000244140625, "invlev_up": 862.5, "invlev_dn": 875.9000244140625, "manhole_up": "manhole_890_generated", "manhole_dn": "manhole_891_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392736.771342770429328, 5866748.462141457945108 ], [ 1392689.222479770891368, 5866733.452325562946498 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E130", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 878.4000244140625, "elevtn_dn": 878.4000244140625, "invlev_up": 875.9000244140625, "invlev_dn": 875.9000244140625, "manhole_up": "manhole_891_generated", "manhole_dn": "manhole_892_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392689.222479770891368, 5866733.452325562946498 ], [ 1392641.673616771353409, 5866718.442509667947888 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E131", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 878.4000244140625, "elevtn_dn": 904.9000244140625, "invlev_up": 875.9000244140625, "invlev_dn": 902.4000244140625, "manhole_up": "manhole_892_generated", "manhole_dn": "manhole_893_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392641.673616771353409, 5866718.442509667947888 ], [ 1392594.124753771815449, 5866703.432693773880601 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E132", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 904.9000244140625, "elevtn_dn": 904.9000244140625, "invlev_up": 902.4000244140625, "invlev_dn": 902.4000244140625, "manhole_up": "manhole_893_generated", "manhole_dn": "manhole_894_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392594.124753771815449, 5866703.432693773880601 ], [ 1392546.575890772277489, 5866688.422877878881991 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E133", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 904.9000244140625, "elevtn_dn": 931.5, "invlev_up": 902.4000244140625, "invlev_dn": 929.0, "manhole_up": "manhole_894_generated", "manhole_dn": "manhole_895_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392546.575890772277489, 5866688.422877878881991 ], [ 1392499.02702777273953, 5866673.413061983883381 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E134", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 931.5, "elevtn_dn": 931.5, "invlev_up": 929.0, "invlev_dn": 929.0, "manhole_up": "manhole_895_generated", "manhole_dn": "manhole_896_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392499.02702777273953, 5866673.413061983883381 ], [ 1392451.47816477320157, 5866658.403246088884771 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E135", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 931.5, "elevtn_dn": 926.29998779296875, "invlev_up": 929.0, "invlev_dn": 923.79998779296875, "manhole_up": "manhole_896_generated", "manhole_dn": "manhole_897_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392451.47816477320157, 5866658.403246088884771 ], [ 1392403.92930177366361, 5866643.393430193886161 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E136", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 926.29998779296875, "elevtn_dn": 849.79998779296875, "invlev_up": 923.79998779296875, "invlev_dn": 847.29998779296875, "manhole_up": "manhole_897_generated", "manhole_dn": "manhole_898_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392403.92930177366361, 5866643.393430193886161 ], [ 1392356.380438774125651, 5866628.383614298887551 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E137", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 849.79998779296875, "elevtn_dn": 875.20001220703125, "invlev_up": 847.29998779296875, "invlev_dn": 872.70001220703125, "manhole_up": "manhole_898_generated", "manhole_dn": "manhole_899_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392356.380438774125651, 5866628.383614298887551 ], [ 1392308.831575774587691, 5866613.373798403888941 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E138", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 875.20001220703125, "elevtn_dn": 875.20001220703125, "invlev_up": 872.70001220703125, "invlev_dn": 872.70001220703125, "manhole_up": "manhole_899_generated", "manhole_dn": "manhole_900_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392308.831575774587691, 5866613.373798403888941 ], [ 1392261.282712775049731, 5866598.363982509821653 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E139", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 875.20001220703125, "elevtn_dn": 928.10003662109375, "invlev_up": 872.70001220703125, "invlev_dn": 925.60003662109375, "manhole_up": "manhole_900_generated", "manhole_dn": "manhole_901_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392261.282712775049731, 5866598.363982509821653 ], [ 1392213.733849775511771, 5866583.354166614823043 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E140", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 928.10003662109375, "elevtn_dn": 928.10003662109375, "invlev_up": 925.60003662109375, "invlev_dn": 925.60003662109375, "manhole_up": "manhole_901_generated", "manhole_dn": "manhole_902_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392213.733849775511771, 5866583.354166614823043 ], [ 1392166.184986775973812, 5866568.344350719824433 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E141", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 928.10003662109375, "elevtn_dn": 936.79998779296875, "invlev_up": 925.60003662109375, "invlev_dn": 934.29998779296875, "manhole_up": "manhole_902_generated", "manhole_dn": "manhole_903_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392166.184986775973812, 5866568.344350719824433 ], [ 1392119.234377897810191, 5866551.59017149079591 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E142", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 936.79998779296875, "elevtn_dn": 936.79998779296875, "invlev_up": 934.29998779296875, "invlev_dn": 934.29998779296875, "manhole_up": "manhole_903_generated", "manhole_dn": "manhole_904_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392119.234377897810191, 5866551.59017149079591 ], [ 1392072.481987217208371, 5866534.25803626794368 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E143", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 936.79998779296875, "elevtn_dn": 929.79998779296875, "invlev_up": 934.29998779296875, "invlev_dn": 927.29998779296875, "manhole_up": "manhole_904_generated", "manhole_dn": "manhole_905_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392072.481987217208371, 5866534.25803626794368 ], [ 1392025.729596536839381, 5866516.925901044160128 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E144", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 929.79998779296875, "elevtn_dn": 892.29998779296875, "invlev_up": 927.29998779296875, "invlev_dn": 889.79998779296875, "manhole_up": "manhole_905_generated", "manhole_dn": "manhole_906_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392025.729596536839381, 5866516.925901044160128 ], [ 1391978.977205856470391, 5866499.593765820376575 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E145", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 892.29998779296875, "elevtn_dn": 911.4000244140625, "invlev_up": 889.79998779296875, "invlev_dn": 908.9000244140625, "manhole_up": "manhole_906_generated", "manhole_dn": "manhole_907_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391978.977205856470391, 5866499.593765820376575 ], [ 1391932.224815175868571, 5866482.261630596593022 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E146", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 911.4000244140625, "elevtn_dn": 911.4000244140625, "invlev_up": 908.9000244140625, "invlev_dn": 908.9000244140625, "manhole_up": "manhole_907_generated", "manhole_dn": "manhole_908_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391932.224815175868571, 5866482.261630596593022 ], [ 1391885.472424495499581, 5866464.92949537280947 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E147", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 911.4000244140625, "elevtn_dn": 933.20001220703125, "invlev_up": 908.9000244140625, "invlev_dn": 930.70001220703125, "manhole_up": "manhole_908_generated", "manhole_dn": "manhole_909_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391885.472424495499581, 5866464.92949537280947 ], [ 1391838.720033814897761, 5866447.59736014995724 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E148", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 933.20001220703125, "elevtn_dn": 933.20001220703125, "invlev_up": 930.70001220703125, "invlev_dn": 930.70001220703125, "manhole_up": "manhole_909_generated", "manhole_dn": "manhole_910_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391838.720033814897761, 5866447.59736014995724 ], [ 1391791.967643134528771, 5866430.265224926173687 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E149", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 933.20001220703125, "elevtn_dn": 939.4000244140625, "invlev_up": 930.70001220703125, "invlev_dn": 936.9000244140625, "manhole_up": "manhole_910_generated", "manhole_dn": "manhole_911_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391791.967643134528771, 5866430.265224926173687 ], [ 1391745.215252453926951, 5866412.933089702390134 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E150", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 939.4000244140625, "elevtn_dn": 939.4000244140625, "invlev_up": 936.9000244140625, "invlev_dn": 936.9000244140625, "manhole_up": "manhole_911_generated", "manhole_dn": "manhole_912_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391745.215252453926951, 5866412.933089702390134 ], [ 1391698.462861773557961, 5866395.600954478606582 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E151", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 939.4000244140625, "elevtn_dn": 952.70001220703125, "invlev_up": 936.9000244140625, "invlev_dn": 950.20001220703125, "manhole_up": "manhole_912_generated", "manhole_dn": "manhole_913_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391698.462861773557961, 5866395.600954478606582 ], [ 1391651.710471092956141, 5866378.268819254823029 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E152", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.70001220703125, "elevtn_dn": 889.4000244140625, "invlev_up": 950.20001220703125, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_913_generated", "manhole_dn": "manhole_914_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391651.710471092956141, 5866378.268819254823029 ], [ 1391604.958080412587151, 5866360.936684031039476 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E153", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 848.70001220703125, "invlev_up": 886.9000244140625, "invlev_dn": 846.20001220703125, "manhole_up": "manhole_914_generated", "manhole_dn": "manhole_915_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391604.958080412587151, 5866360.936684031039476 ], [ 1391558.205689732218161, 5866343.604548808187246 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E154", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 848.70001220703125, "elevtn_dn": 848.70001220703125, "invlev_up": 846.20001220703125, "invlev_dn": 846.20001220703125, "manhole_up": "manhole_915_generated", "manhole_dn": "manhole_916_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391558.205689732218161, 5866343.604548808187246 ], [ 1391511.453299051616341, 5866326.272413584403694 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E155", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 848.70001220703125, "elevtn_dn": 846.0, "invlev_up": 846.20001220703125, "invlev_dn": 843.5, "manhole_up": "manhole_916_generated", "manhole_dn": "manhole_917_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391511.453299051616341, 5866326.272413584403694 ], [ 1391464.700908371247351, 5866308.940278360620141 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E156", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 846.0, "elevtn_dn": 846.0, "invlev_up": 843.5, "invlev_dn": 843.5, "manhole_up": "manhole_917_generated", "manhole_dn": "manhole_918_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391464.700908371247351, 5866308.940278360620141 ], [ 1391417.948517690645531, 5866291.608143136836588 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E157", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 846.0, "elevtn_dn": 849.9000244140625, "invlev_up": 843.5, "invlev_dn": 847.4000244140625, "manhole_up": "manhole_918_generated", "manhole_dn": "manhole_919_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391417.948517690645531, 5866291.608143136836588 ], [ 1391371.196127010276541, 5866274.276007913053036 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E158", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 849.9000244140625, "elevtn_dn": 849.9000244140625, "invlev_up": 847.4000244140625, "invlev_dn": 847.4000244140625, "manhole_up": "manhole_919_generated", "manhole_dn": "manhole_920_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391371.196127010276541, 5866274.276007913053036 ], [ 1391321.986832652939484, 5866269.550851707346737 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E159", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 849.9000244140625, "elevtn_dn": 895.70001220703125, "invlev_up": 847.4000244140625, "invlev_dn": 893.20001220703125, "manhole_up": "manhole_920_generated", "manhole_dn": "manhole_921_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391321.986832652939484, 5866269.550851707346737 ], [ 1391272.147464629728347, 5866268.058758955448866 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E160", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 895.70001220703125, "elevtn_dn": 895.70001220703125, "invlev_up": 893.20001220703125, "invlev_dn": 893.20001220703125, "manhole_up": "manhole_921_generated", "manhole_dn": "manhole_922_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391272.147464629728347, 5866268.058758955448866 ], [ 1391222.30809660628438, 5866266.566666204482317 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E161", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 895.70001220703125, "elevtn_dn": 932.0, "invlev_up": 893.20001220703125, "invlev_dn": 929.5, "manhole_up": "manhole_922_generated", "manhole_dn": "manhole_923_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391222.30809660628438, 5866266.566666204482317 ], [ 1391172.468728582840413, 5866265.074573452584445 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E162", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 932.0, "invlev_up": 929.5, "invlev_dn": 929.5, "manhole_up": "manhole_923_generated", "manhole_dn": "manhole_924_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391172.468728582840413, 5866265.074573452584445 ], [ 1391122.629360559629276, 5866263.582480700686574 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E163", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 915.20001220703125, "invlev_up": 929.5, "invlev_dn": 912.70001220703125, "manhole_up": "manhole_924_generated", "manhole_dn": "manhole_925_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391122.629360559629276, 5866263.582480700686574 ], [ 1391072.789992536185309, 5866262.090387949720025 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E164", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.20001220703125, "elevtn_dn": 880.70001220703125, "invlev_up": 912.70001220703125, "invlev_dn": 878.20001220703125, "manhole_up": "manhole_925_generated", "manhole_dn": "manhole_926_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391072.789992536185309, 5866262.090387949720025 ], [ 1391022.950624512741342, 5866260.598295197822154 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E165", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 880.70001220703125, "elevtn_dn": 880.70001220703125, "invlev_up": 878.20001220703125, "invlev_dn": 878.20001220703125, "manhole_up": "manhole_926_generated", "manhole_dn": "manhole_927_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391022.950624512741342, 5866260.598295197822154 ], [ 1390973.111256489530206, 5866259.106202445924282 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E166", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 880.70001220703125, "elevtn_dn": 889.4000244140625, "invlev_up": 878.20001220703125, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_927_generated", "manhole_dn": "manhole_928_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390973.111256489530206, 5866259.106202445924282 ], [ 1390923.271888466086239, 5866257.614109694957733 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E167", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 889.4000244140625, "invlev_up": 886.9000244140625, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_928_generated", "manhole_dn": "manhole_929_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390923.271888466086239, 5866257.614109694957733 ], [ 1390873.432520442642272, 5866256.122016943059862 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E168", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 935.79998779296875, "invlev_up": 886.9000244140625, "invlev_dn": 933.29998779296875, "manhole_up": "manhole_929_generated", "manhole_dn": "manhole_930_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390873.432520442642272, 5866256.122016943059862 ], [ 1390823.593152419198304, 5866254.62992419116199 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E169", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.79998779296875, "elevtn_dn": 935.79998779296875, "invlev_up": 933.29998779296875, "invlev_dn": 933.29998779296875, "manhole_up": "manhole_930_generated", "manhole_dn": "manhole_931_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390823.593152419198304, 5866254.62992419116199 ], [ 1390773.753784395987168, 5866253.137831440195441 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E170", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.79998779296875, "elevtn_dn": 957.79998779296875, "invlev_up": 933.29998779296875, "invlev_dn": 955.29998779296875, "manhole_up": "manhole_931_generated", "manhole_dn": "manhole_932_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390773.753784395987168, 5866253.137831440195441 ], [ 1390723.914416372543201, 5866251.64573868829757 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E171", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.79998779296875, "elevtn_dn": 957.79998779296875, "invlev_up": 955.29998779296875, "invlev_dn": 955.29998779296875, "manhole_up": "manhole_932_generated", "manhole_dn": "manhole_933_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390723.914416372543201, 5866251.64573868829757 ], [ 1390674.075048349099234, 5866250.153645936399698 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E172", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.79998779296875, "elevtn_dn": 957.0, "invlev_up": 955.29998779296875, "invlev_dn": 954.5, "manhole_up": "manhole_933_generated", "manhole_dn": "manhole_934_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390674.075048349099234, 5866250.153645936399698 ], [ 1390624.235680325888097, 5866248.661553185433149 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E173", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.0, "elevtn_dn": 957.0, "invlev_up": 954.5, "invlev_dn": 954.5, "manhole_up": "manhole_934_generated", "manhole_dn": "manhole_935_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390624.235680325888097, 5866248.661553185433149 ], [ 1390574.39631230244413, 5866247.169460433535278 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E174", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.0, "elevtn_dn": 964.5, "invlev_up": 954.5, "invlev_dn": 962.0, "manhole_up": "manhole_935_generated", "manhole_dn": "manhole_936_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390574.39631230244413, 5866247.169460433535278 ], [ 1390524.556944279000163, 5866245.677367681637406 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E175", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 964.5, "invlev_up": 962.0, "invlev_dn": 962.0, "manhole_up": "manhole_936_generated", "manhole_dn": "manhole_937_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390524.556944279000163, 5866245.677367681637406 ], [ 1390474.717576255789027, 5866244.185274930670857 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E176", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 948.5, "invlev_up": 962.0, "invlev_dn": 946.0, "manhole_up": "manhole_937_generated", "manhole_dn": "manhole_938_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390474.717576255789027, 5866244.185274930670857 ], [ 1390424.87820823234506, 5866242.693182178772986 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E177", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 948.5, "elevtn_dn": 970.10003662109375, "invlev_up": 946.0, "invlev_dn": 967.60003662109375, "manhole_up": "manhole_938_generated", "manhole_dn": "manhole_939_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390424.87820823234506, 5866242.693182178772986 ], [ 1390375.038840208901092, 5866241.201089426875114 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E178", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 970.10003662109375, "elevtn_dn": 970.10003662109375, "invlev_up": 967.60003662109375, "invlev_dn": 967.60003662109375, "manhole_up": "manhole_939_generated", "manhole_dn": "manhole_940_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390375.038840208901092, 5866241.201089426875114 ], [ 1390325.199472185689956, 5866239.708996675908566 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E179", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 970.10003662109375, "elevtn_dn": 975.4000244140625, "invlev_up": 967.60003662109375, "invlev_dn": 972.9000244140625, "manhole_up": "manhole_940_generated", "manhole_dn": "manhole_941_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390325.199472185689956, 5866239.708996675908566 ], [ 1390275.360104162245989, 5866238.216903924010694 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E180", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 975.4000244140625, "elevtn_dn": 975.4000244140625, "invlev_up": 972.9000244140625, "invlev_dn": 972.9000244140625, "manhole_up": "manhole_941_generated", "manhole_dn": "manhole_942_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390275.360104162245989, 5866238.216903924010694 ], [ 1390225.520736138802022, 5866236.724811173044145 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E181", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 975.4000244140625, "elevtn_dn": 1034.5, "invlev_up": 972.9000244140625, "invlev_dn": 1032.0, "manhole_up": "manhole_942_generated", "manhole_dn": "manhole_943_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390225.520736138802022, 5866236.724811173044145 ], [ 1390175.681368115358055, 5866235.232718421146274 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E182", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1034.5, "elevtn_dn": 1034.5, "invlev_up": 1032.0, "invlev_dn": 1032.0, "manhole_up": "manhole_943_generated", "manhole_dn": "manhole_944_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390175.681368115358055, 5866235.232718421146274 ], [ 1390125.842000092146918, 5866233.740625669248402 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E183", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1034.5, "elevtn_dn": 1053.9000244140625, "invlev_up": 1032.0, "invlev_dn": 1051.4000244140625, "manhole_up": "manhole_944_generated", "manhole_dn": "manhole_945_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390125.842000092146918, 5866233.740625669248402 ], [ 1390076.002632068702951, 5866232.248532918281853 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E184", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1053.9000244140625, "elevtn_dn": 956.9000244140625, "invlev_up": 1051.4000244140625, "invlev_dn": 954.4000244140625, "manhole_up": "manhole_945_generated", "manhole_dn": "manhole_946_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390076.002632068702951, 5866232.248532918281853 ], [ 1390026.163264045258984, 5866230.756440166383982 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E185", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 956.9000244140625, "elevtn_dn": 988.79998779296875, "invlev_up": 954.4000244140625, "invlev_dn": 986.29998779296875, "manhole_up": "manhole_946_generated", "manhole_dn": "manhole_947_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390026.163264045258984, 5866230.756440166383982 ], [ 1389976.323896022047848, 5866229.26434741448611 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E186", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 988.79998779296875, "elevtn_dn": 988.79998779296875, "invlev_up": 986.29998779296875, "invlev_dn": 986.29998779296875, "manhole_up": "manhole_947_generated", "manhole_dn": "manhole_948_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389976.323896022047848, 5866229.26434741448611 ], [ 1389926.48452799860388, 5866227.772254663519561 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E187", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 988.79998779296875, "elevtn_dn": 1051.0999755859375, "invlev_up": 986.29998779296875, "invlev_dn": 1048.5999755859375, "manhole_up": "manhole_948_generated", "manhole_dn": "manhole_949_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389926.48452799860388, 5866227.772254663519561 ], [ 1389876.645159975159913, 5866226.28016191162169 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E188", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1051.0999755859375, "elevtn_dn": 1051.0999755859375, "invlev_up": 1048.5999755859375, "invlev_dn": 1048.5999755859375, "manhole_up": "manhole_949_generated", "manhole_dn": "manhole_950_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389876.645159975159913, 5866226.28016191162169 ], [ 1389826.805791951948777, 5866224.788069159723818 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E189", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1051.0999755859375, "elevtn_dn": 1066.9000244140625, "invlev_up": 1048.5999755859375, "invlev_dn": 1064.4000244140625, "manhole_up": "manhole_950_generated", "manhole_dn": "manhole_951_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389826.805791951948777, 5866224.788069159723818 ], [ 1389776.96642392850481, 5866223.295976408757269 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E190", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1066.9000244140625, "elevtn_dn": 1031.2000732421875, "invlev_up": 1064.4000244140625, "invlev_dn": 1028.7000732421875, "manhole_up": "manhole_951_generated", "manhole_dn": "manhole_952_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389776.96642392850481, 5866223.295976408757269 ], [ 1389727.141182830790058, 5866221.468200048431754 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E191", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1031.2000732421875, "elevtn_dn": 1031.2000732421875, "invlev_up": 1028.7000732421875, "invlev_dn": 1028.7000732421875, "manhole_up": "manhole_952_generated", "manhole_dn": "manhole_953_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389727.141182830790058, 5866221.468200048431754 ], [ 1389677.352675863076001, 5866218.767548334784806 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E192", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1031.2000732421875, "elevtn_dn": 986.60003662109375, "invlev_up": 1028.7000732421875, "invlev_dn": 984.10003662109375, "manhole_up": "manhole_953_generated", "manhole_dn": "manhole_954_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389677.352675863076001, 5866218.767548334784806 ], [ 1389627.564168895594776, 5866216.066896621137857 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E193", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 986.60003662109375, "elevtn_dn": 986.60003662109375, "invlev_up": 984.10003662109375, "invlev_dn": 984.10003662109375, "manhole_up": "manhole_954_generated", "manhole_dn": "manhole_955_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389627.564168895594776, 5866216.066896621137857 ], [ 1389577.775661927880719, 5866213.366244907490909 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E194", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 986.60003662109375, "elevtn_dn": 964.70001220703125, "invlev_up": 984.10003662109375, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_955_generated", "manhole_dn": "manhole_956_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389577.775661927880719, 5866213.366244907490909 ], [ 1389527.987154960166663, 5866210.665593194775283 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E195", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 964.70001220703125, "invlev_up": 962.20001220703125, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_956_generated", "manhole_dn": "manhole_957_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389527.987154960166663, 5866210.665593194775283 ], [ 1389478.198647992452607, 5866207.964941481128335 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E196", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 996.29998779296875, "invlev_up": 962.20001220703125, "invlev_dn": 993.79998779296875, "manhole_up": "manhole_957_generated", "manhole_dn": "manhole_958_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389478.198647992452607, 5866207.964941481128335 ], [ 1389428.41014102473855, 5866205.264289767481387 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E197", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 996.29998779296875, "elevtn_dn": 996.29998779296875, "invlev_up": 993.79998779296875, "invlev_dn": 993.79998779296875, "manhole_up": "manhole_958_generated", "manhole_dn": "manhole_959_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389428.41014102473855, 5866205.264289767481387 ], [ 1389378.621634057024494, 5866202.563638053834438 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E198", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 996.29998779296875, "elevtn_dn": 1030.4000244140625, "invlev_up": 993.79998779296875, "invlev_dn": 1027.9000244140625, "manhole_up": "manhole_959_generated", "manhole_dn": "manhole_960_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389378.621634057024494, 5866202.563638053834438 ], [ 1389328.833127089310437, 5866199.86298634018749 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E199", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1030.4000244140625, "elevtn_dn": 1030.4000244140625, "invlev_up": 1027.9000244140625, "invlev_dn": 1027.9000244140625, "manhole_up": "manhole_960_generated", "manhole_dn": "manhole_961_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389328.833127089310437, 5866199.86298634018749 ], [ 1389279.044620121829212, 5866197.162334626540542 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E200", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1030.4000244140625, "elevtn_dn": 1053.800048828125, "invlev_up": 1027.9000244140625, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_961_generated", "manhole_dn": "manhole_962_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389279.044620121829212, 5866197.162334626540542 ], [ 1389229.256113154115155, 5866194.461682912893593 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E201", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1053.800048828125, "invlev_up": 1051.300048828125, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_962_generated", "manhole_dn": "manhole_963_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389229.256113154115155, 5866194.461682912893593 ], [ 1389179.467606186401099, 5866191.761031199246645 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E202", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1067.5999755859375, "invlev_up": 1051.300048828125, "invlev_dn": 1065.0999755859375, "manhole_up": "manhole_963_generated", "manhole_dn": "manhole_964_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389179.467606186401099, 5866191.761031199246645 ], [ 1389129.679099218687043, 5866189.060379485599697 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E203", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1067.5999755859375, "elevtn_dn": 1070.7000732421875, "invlev_up": 1065.0999755859375, "invlev_dn": 1068.2000732421875, "manhole_up": "manhole_964_generated", "manhole_dn": "manhole_965_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389129.679099218687043, 5866189.060379485599697 ], [ 1389079.890592250972986, 5866186.359727771952748 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E204", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1070.7000732421875, "elevtn_dn": 1070.7000732421875, "invlev_up": 1068.2000732421875, "invlev_dn": 1068.2000732421875, "manhole_up": "manhole_965_generated", "manhole_dn": "manhole_966_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389079.890592250972986, 5866186.359727771952748 ], [ 1389030.10208528325893, 5866183.6590760583058 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E205", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1070.7000732421875, "elevtn_dn": 1075.0, "invlev_up": 1068.2000732421875, "invlev_dn": 1072.5, "manhole_up": "manhole_966_generated", "manhole_dn": "manhole_967_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389030.10208528325893, 5866183.6590760583058 ], [ 1388980.313578315777704, 5866180.958424345590174 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E206", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1075.0, "elevtn_dn": 1075.0, "invlev_up": 1072.5, "invlev_dn": 1072.5, "manhole_up": "manhole_967_generated", "manhole_dn": "manhole_968_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388980.313578315777704, 5866180.958424345590174 ], [ 1388930.525071348063648, 5866178.257772631943226 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E207", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1075.0, "elevtn_dn": 1074.0999755859375, "invlev_up": 1072.5, "invlev_dn": 1071.5999755859375, "manhole_up": "manhole_968_generated", "manhole_dn": "manhole_969_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388930.525071348063648, 5866178.257772631943226 ], [ 1388880.736564380349591, 5866175.557120918296278 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E208", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1074.0999755859375, "elevtn_dn": 1074.0999755859375, "invlev_up": 1071.5999755859375, "invlev_dn": 1071.5999755859375, "manhole_up": "manhole_969_generated", "manhole_dn": "manhole_970_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388880.736564380349591, 5866175.557120918296278 ], [ 1388830.948057412635535, 5866172.856469204649329 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E209", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1074.0999755859375, "elevtn_dn": 1053.800048828125, "invlev_up": 1071.5999755859375, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_970_generated", "manhole_dn": "manhole_971_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388830.948057412635535, 5866172.856469204649329 ], [ 1388781.159550444921479, 5866170.155817491002381 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E210", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1053.800048828125, "invlev_up": 1051.300048828125, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_971_generated", "manhole_dn": "manhole_972_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388781.159550444921479, 5866170.155817491002381 ], [ 1388731.371043477207422, 5866167.455165777355433 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E211", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1017.0, "invlev_up": 1051.300048828125, "invlev_dn": 1014.5, "manhole_up": "manhole_972_generated", "manhole_dn": "manhole_973_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388731.371043477207422, 5866167.455165777355433 ], [ 1388681.582536509493366, 5866164.754514063708484 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E212", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1017.0, "elevtn_dn": 1017.0, "invlev_up": 1014.5, "invlev_dn": 1014.5, "manhole_up": "manhole_973_generated", "manhole_dn": "manhole_974_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388681.582536509493366, 5866164.754514063708484 ], [ 1388631.79402954201214, 5866162.053862350061536 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E213", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1017.0, "elevtn_dn": 973.20001220703125, "invlev_up": 1014.5, "invlev_dn": 970.70001220703125, "manhole_up": "manhole_974_generated", "manhole_dn": "manhole_975_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388631.79402954201214, 5866162.053862350061536 ], [ 1388582.005522574298084, 5866159.353210636414587 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E214", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 973.20001220703125, "elevtn_dn": 973.20001220703125, "invlev_up": 970.70001220703125, "invlev_dn": 970.70001220703125, "manhole_up": "manhole_975_generated", "manhole_dn": "manhole_976_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388582.005522574298084, 5866159.353210636414587 ], [ 1388532.217015606584027, 5866156.652558922767639 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E215", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 973.20001220703125, "elevtn_dn": 935.20001220703125, "invlev_up": 970.70001220703125, "invlev_dn": 932.70001220703125, "manhole_up": "manhole_976_generated", "manhole_dn": "manhole_977_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388532.217015606584027, 5866156.652558922767639 ], [ 1388482.428508638869971, 5866153.951907209120691 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E216", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.20001220703125, "elevtn_dn": 935.20001220703125, "invlev_up": 932.70001220703125, "invlev_dn": 932.70001220703125, "manhole_up": "manhole_977_generated", "manhole_dn": "manhole_978_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388482.428508638869971, 5866153.951907209120691 ], [ 1388432.640001671155915, 5866151.251255496405065 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E217", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.20001220703125, "elevtn_dn": 895.79998779296875, "invlev_up": 932.70001220703125, "invlev_dn": 893.29998779296875, "manhole_up": "manhole_978_generated", "manhole_dn": "manhole_979_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388432.640001671155915, 5866151.251255496405065 ], [ 1388382.851494703441858, 5866148.550603782758117 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E218", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 895.79998779296875, "elevtn_dn": 852.60003662109375, "invlev_up": 893.29998779296875, "invlev_dn": 850.10003662109375, "manhole_up": "manhole_979_generated", "manhole_dn": "manhole_980_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388382.851494703441858, 5866148.550603782758117 ], [ 1388333.062987735960633, 5866145.849952069111168 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E219", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 852.60003662109375, "elevtn_dn": 852.60003662109375, "invlev_up": 850.10003662109375, "invlev_dn": 850.10003662109375, "manhole_up": "manhole_980_generated", "manhole_dn": "manhole_981_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388333.062987735960633, 5866145.849952069111168 ], [ 1388283.274480768246576, 5866143.14930035546422 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E220", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 852.60003662109375, "elevtn_dn": 818.4000244140625, "invlev_up": 850.10003662109375, "invlev_dn": 815.9000244140625, "manhole_up": "manhole_981_generated", "manhole_dn": "manhole_982_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388283.274480768246576, 5866143.14930035546422 ], [ 1388233.48597380053252, 5866140.448648641817272 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E221", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 818.4000244140625, "elevtn_dn": 818.4000244140625, "invlev_up": 815.9000244140625, "invlev_dn": 815.9000244140625, "manhole_up": "manhole_982_generated", "manhole_dn": "manhole_983_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388233.48597380053252, 5866140.448648641817272 ], [ 1388183.697466832818463, 5866137.747996928170323 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_50_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 792.20001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_851_generated", "manhole_dn": "manhole_984_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387913.197226775344461, 5865736.839239663444459 ], [ 1387925.20445894007571, 5865784.545682998374104 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_50_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 804.4000244140625, "invlev_up": 792.20001220703125, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_984_generated", "manhole_dn": "manhole_985_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387925.20445894007571, 5865784.545682998374104 ], [ 1387937.21169110503979, 5865832.252126332372427 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_50_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_985_generated", "manhole_dn": "manhole_986_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387937.21169110503979, 5865832.252126332372427 ], [ 1387954.8270876808092, 5865878.043407939374447 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_50_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_986_generated", "manhole_dn": "manhole_987_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387954.8270876808092, 5865878.043407939374447 ], [ 1387967.620662312954664, 5865925.436966767534614 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_50_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 778.20001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_987_generated", "manhole_dn": "manhole_988_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387967.620662312954664, 5865925.436966767534614 ], [ 1387969.561903131194413, 5865974.386314341798425 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_50_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_988_generated", "manhole_dn": "manhole_989_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.561903131194413, 5865974.386314341798425 ], [ 1387968.98255812516436, 5866023.571071763522923 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_50_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_989_generated", "manhole_dn": "manhole_990_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387968.98255812516436, 5866023.571071763522923 ], [ 1387969.225197304505855, 5866072.657253311946988 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_50_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 786.29998779296875, "invlev_up": 775.70001220703125, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_990_generated", "manhole_dn": "manhole_991_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.225197304505855, 5866072.657253311946988 ], [ 1387988.247399942483753, 5866112.298415473662317 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_50_E8", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 786.29998779296875, "invlev_up": 783.79998779296875, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_991_generated", "manhole_dn": "manhole_992_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387988.247399942483753, 5866112.298415473662317 ], [ 1388034.037428337847814, 5866130.255607943050563 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_51_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 786.29998779296875, "invlev_up": 783.79998779296875, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_992_generated", "manhole_dn": "manhole_993_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388034.037428337847814, 5866130.255607943050563 ], [ 1387988.210684564430267, 5866144.678138472139835 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_51_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 803.9000244140625, "invlev_up": 783.79998779296875, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_993_generated", "manhole_dn": "manhole_994_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387988.210684564430267, 5866144.678138472139835 ], [ 1387944.406121137319133, 5866164.065103021450341 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_51_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_994_generated", "manhole_dn": "manhole_995_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387944.406121137319133, 5866164.065103021450341 ], [ 1387898.376188111724332, 5866173.560075835324824 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_51_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 827.70001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_995_generated", "manhole_dn": "manhole_996_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387898.376188111724332, 5866173.560075835324824 ], [ 1387861.922560503939167, 5866145.113870099186897 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_51_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_996_generated", "manhole_dn": "manhole_997_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387861.922560503939167, 5866145.113870099186897 ], [ 1387862.597008766839281, 5866099.287653629668057 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_51_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_997_generated", "manhole_dn": "manhole_998_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387862.597008766839281, 5866099.287653629668057 ], [ 1387894.296242429409176, 5866064.31225199252367 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_51_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_998_generated", "manhole_dn": "manhole_999_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387894.296242429409176, 5866064.31225199252367 ], [ 1387918.333023339277133, 5866023.860149594023824 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_51_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_999_generated", "manhole_dn": "manhole_1000_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387918.333023339277133, 5866023.860149594023824 ], [ 1387925.576027213362977, 5865976.462517648003995 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_51_E8", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 804.4000244140625, "invlev_up": 814.20001220703125, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1000_generated", "manhole_dn": "manhole_1001_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387925.576027213362977, 5865976.462517648003995 ], [ 1387926.166851800866425, 5865928.505292822606862 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_51_E9", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1001_generated", "manhole_dn": "manhole_1002_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387926.166851800866425, 5865928.505292822606862 ], [ 1387922.175474973395467, 5865880.628693707287312 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_51_E10", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1002_generated", "manhole_dn": "manhole_1003_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387922.175474973395467, 5865880.628693707287312 ], [ 1387918.184098146157339, 5865832.752094592899084 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_51_E11", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 794.70001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_1003_generated", "manhole_dn": "manhole_1004_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387918.184098146157339, 5865832.752094592899084 ], [ 1387914.316889721900225, 5865784.868878290057182 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_51_E12", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 792.20001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_1004_generated", "manhole_dn": "manhole_851_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387914.316889721900225, 5865784.868878290057182 ], [ 1387913.197226775344461, 5865736.839239663444459 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_52_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_52", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 818.4000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 815.9000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_983_generated", "manhole_dn": "manhole_1005_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388183.697466832818463, 5866137.747996928170323 ], [ 1388133.810787334572524, 5866135.250533932819963 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_52_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_52", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_1005_generated", "manhole_dn": "manhole_1006_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388133.810787334572524, 5866135.250533932819963 ], [ 1388083.924107836093754, 5866132.753070938400924 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_52_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_52", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 786.29998779296875, "invlev_up": 801.4000244140625, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_1006_generated", "manhole_dn": "manhole_992_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388083.924107836093754, 5866132.753070938400924 ], [ 1388034.037428337847814, 5866130.255607943050563 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "bedlev": 849.79998779296875, "branchid": "river_1", "width": 60.500781333333329, "height": 24.5, "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_1", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1393117.044156666612253, 5866704.071640181355178 ], [ 1393024.277914338745177, 5866704.071640181355178 ], [ 1392931.511672010878101, 5866704.071640181355178 ], [ 1392838.745429683011025, 5866704.071640181355178 ], [ 1392745.979187355143949, 5866569.217538605444133 ], [ 1392653.212945027276874, 5866569.217538605444133 ], [ 1392560.446702699409798, 5866569.217538605444133 ], [ 1392467.680460371775553, 5866569.217538605444133 ], [ 1392374.914218043908477, 5866569.217538605444133 ], [ 1392282.147975716041401, 5866434.365506432019174 ], [ 1392189.381733388174325, 5866299.515543566085398 ], [ 1392096.615491060307249, 5866299.515543566085398 ], [ 1392003.849248732440174, 5866299.515543566085398 ], [ 1391911.083006404573098, 5866299.515543566085398 ], [ 1391818.316764076706022, 5866164.667649917304516 ], [ 1391725.550521749071777, 5866164.667649917304516 ], [ 1391632.784279421204701, 5866164.667649917304516 ], [ 1391540.018037093337625, 5866164.667649917304516 ], [ 1391447.251794765470549, 5866164.667649917304516 ], [ 1391354.485552437603474, 5866164.667649917304516 ], [ 1391261.719310109736398, 5866164.667649917304516 ], [ 1391168.953067781869322, 5866164.667649917304516 ], [ 1391076.186825454002246, 5866164.667649917304516 ], [ 1390983.42058312613517, 5866164.667649917304516 ], [ 1390890.654340798500925, 5866164.667649917304516 ], [ 1390797.88809847063385, 5866029.821825393475592 ], [ 1390705.121856142766774, 5866029.821825393475592 ], [ 1390612.355613814899698, 5866029.821825393475592 ], [ 1390519.589371487032622, 5866029.821825393475592 ], [ 1390426.823129159165546, 5866029.821825393475592 ], [ 1390334.05688683129847, 5866029.821825393475592 ], [ 1390241.290644503431395, 5866029.821825393475592 ], [ 1390148.524402175564319, 5865894.978069900535047 ], [ 1390055.758159847930074, 5865894.978069900535047 ], [ 1389962.991917520062998, 5865760.136383350938559 ], [ 1389870.225675192195922, 5865760.136383350938559 ], [ 1389777.459432864328846, 5865760.136383350938559 ], [ 1389684.693190536461771, 5865760.136383350938559 ], [ 1389591.926948208594695, 5865760.136383350938559 ], [ 1389499.160705880727619, 5865625.296765648759902 ], [ 1389406.394463552860543, 5865625.296765648759902 ], [ 1389406.394463552860543, 5865490.459216703660786 ], [ 1389313.628221225226298, 5865355.623736422508955 ], [ 1389313.628221225226298, 5865220.790324714966118 ], [ 1389313.628221225226298, 5865085.958981487900019 ], [ 1389220.861978897359222, 5864951.129706649109721 ], [ 1389128.095736569492146, 5864816.302500107325613 ], [ 1389128.095736569492146, 5864681.477361768484116 ], [ 1389035.329494241625071, 5864546.654291545040905 ], [ 1389128.095736569492146, 5864411.833289341069758 ], [ 1389128.095736569492146, 5864277.014355066232383 ], [ 1389035.329494241625071, 5864142.197488628327847 ], [ 1388942.563251913757995, 5864007.382689935155213 ], [ 1388849.797009585890919, 5863872.56995889544487 ], [ 1388757.030767258023843, 5863872.56995889544487 ], [ 1388664.264524930156767, 5863737.759295415133238 ], [ 1388571.498282602289692, 5863602.950699404813349 ], [ 1388571.498282602289692, 5863468.144170772284269 ], [ 1388571.498282602289692, 5863333.339709425345063 ], [ 1388478.732040274655446, 5863333.339709425345063 ], [ 1388385.965797946788371, 5863198.537315271794796 ], [ 1388293.199555618921295, 5863198.537315271794796 ], [ 1388200.433313291054219, 5863198.537315271794796 ], [ 1388107.667070963187143, 5863063.73698821850121 ], [ 1388014.900828635320067, 5863063.73698821850121 ], [ 1387922.134586307452992, 5863063.73698821850121 ], [ 1387829.368343979585916, 5862928.938728175126016 ], [ 1387736.60210165171884, 5862794.142535049468279 ], [ 1387736.60210165171884, 5862659.348408750258386 ], [ 1387736.60210165171884, 5862524.55634918436408 ], [ 1387643.835859324084595, 5862389.766356258653104 ], [ 1387551.069616996217519, 5862254.978429885581136 ], [ 1387458.303374668350443, 5862254.978429885581136 ], [ 1387365.537132340483367, 5862254.978429885581136 ], [ 1387272.770890012616292, 5862254.978429885581136 ], [ 1387180.004647684749216, 5862254.978429885581136 ], [ 1387087.23840535688214, 5862254.978429885581136 ], [ 1386994.472163029015064, 5862120.19256996922195 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "bedlev": 789.5, "branchid": "river_2", "width": 63.595319, "height": 15.025009155273438, "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_2", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1387829.368343979585916, 5866704.071640181355178 ], [ 1387829.368343979585916, 5866569.217538605444133 ], [ 1387922.134586307452992, 5866434.365506432019174 ], [ 1387922.134586307452992, 5866299.515543566085398 ], [ 1388014.900828635320067, 5866164.667649917304516 ], [ 1388014.900828635320067, 5866029.821825393475592 ], [ 1388014.900828635320067, 5865894.978069900535047 ], [ 1388014.900828635320067, 5865760.136383350938559 ], [ 1387922.134586307452992, 5865625.296765648759902 ], [ 1387922.134586307452992, 5865490.459216703660786 ], [ 1387922.134586307452992, 5865355.623736422508955 ], [ 1387922.134586307452992, 5865220.790324714966118 ], [ 1387922.134586307452992, 5865085.958981487900019 ], [ 1387829.368343979585916, 5864951.129706649109721 ], [ 1387829.368343979585916, 5864816.302500107325613 ], [ 1387829.368343979585916, 5864681.477361768484116 ], [ 1387829.368343979585916, 5864546.654291545040905 ], [ 1387829.368343979585916, 5864411.833289341069758 ], [ 1387829.368343979585916, 5864277.014355066232383 ], [ 1387736.60210165171884, 5864142.197488628327847 ], [ 1387643.835859324084595, 5864007.382689935155213 ], [ 1387551.069616996217519, 5863872.56995889544487 ], [ 1387551.069616996217519, 5863737.759295415133238 ], [ 1387458.303374668350443, 5863602.950699404813349 ], [ 1387365.537132340483367, 5863468.144170772284269 ], [ 1387272.770890012616292, 5863333.339709425345063 ], [ 1387272.770890012616292, 5863198.537315271794796 ], [ 1387180.004647684749216, 5863063.73698821850121 ], [ 1387087.23840535688214, 5862928.938728175126016 ], [ 1386994.472163029015064, 5862794.142535049468279 ], [ 1386901.705920701380819, 5862794.142535049468279 ], [ 1386808.939678373513743, 5862659.348408750258386 ], [ 1386716.173436045646667, 5862524.55634918436408 ], [ 1386716.173436045646667, 5862389.766356258653104 ], [ 1386716.173436045646667, 5862254.978429885581136 ], [ 1386808.939678373513743, 5862254.978429885581136 ], [ 1386901.705920701380819, 5862120.19256996922195 ], [ 1386994.472163029015064, 5862120.19256996922195 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "bedlev": 952.79998779296875, "branchid": "river_3", "width": 50.0, "height": 21.70001220703125, "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_3", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1391540.018037093337625, 5858077.577220032922924 ], [ 1391447.251794765470549, 5858077.577220032922924 ], [ 1391354.485552437603474, 5858077.577220032922924 ], [ 1391261.719310109736398, 5858077.577220032922924 ], [ 1391168.953067781869322, 5858077.577220032922924 ], [ 1391076.186825454002246, 5858212.301128901541233 ], [ 1390983.42058312613517, 5858212.301128901541233 ], [ 1390890.654340798500925, 5858212.301128901541233 ], [ 1390797.88809847063385, 5858077.577220032922924 ], [ 1390705.121856142766774, 5858077.577220032922924 ], [ 1390612.355613814899698, 5858077.577220032922924 ], [ 1390519.589371487032622, 5858077.577220032922924 ], [ 1390426.823129159165546, 5858077.577220032922924 ], [ 1390334.05688683129847, 5857942.855374775826931 ], [ 1390241.290644503431395, 5857942.855374775826931 ], [ 1390148.524402175564319, 5857942.855374775826931 ], [ 1390055.758159847930074, 5857808.135593039914966 ], [ 1389962.991917520062998, 5857808.135593039914966 ], [ 1389962.991917520062998, 5857673.417874733917415 ], [ 1389870.225675192195922, 5857673.417874733917415 ], [ 1389777.459432864328846, 5857673.417874733917415 ], [ 1389684.693190536461771, 5857808.135593039914966 ], [ 1389591.926948208594695, 5857808.135593039914966 ], [ 1389499.160705880727619, 5857808.135593039914966 ], [ 1389406.394463552860543, 5857808.135593039914966 ], [ 1389313.628221225226298, 5857942.855374775826931 ], [ 1389220.861978897359222, 5858077.577220032922924 ], [ 1389128.095736569492146, 5858212.301128901541233 ], [ 1389035.329494241625071, 5858212.301128901541233 ], [ 1388942.563251913757995, 5858347.02710147574544 ], [ 1388849.797009585890919, 5858347.02710147574544 ], [ 1388757.030767258023843, 5858347.02710147574544 ], [ 1388664.264524930156767, 5858481.75513784494251 ], [ 1388571.498282602289692, 5858481.75513784494251 ], [ 1388478.732040274655446, 5858481.75513784494251 ], [ 1388385.965797946788371, 5858481.75513784494251 ], [ 1388293.199555618921295, 5858481.75513784494251 ], [ 1388200.433313291054219, 5858616.485238100402057 ], [ 1388107.667070963187143, 5858751.217402335256338 ], [ 1388014.900828635320067, 5858885.951630644500256 ], [ 1387922.134586307452992, 5858885.951630644500256 ], [ 1387829.368343979585916, 5858885.951630644500256 ], [ 1387736.60210165171884, 5858885.951630644500256 ], [ 1387643.835859324084595, 5858885.951630644500256 ], [ 1387551.069616996217519, 5858885.951630644500256 ], [ 1387458.303374668350443, 5858885.951630644500256 ], [ 1387365.537132340483367, 5858885.951630644500256 ], [ 1387272.770890012616292, 5858885.951630644500256 ], [ 1387180.004647684749216, 5858885.951630644500256 ], [ 1387087.23840535688214, 5858885.951630644500256 ], [ 1386994.472163029015064, 5858885.951630644500256 ], [ 1386901.705920701380819, 5858885.951630644500256 ], [ 1386808.939678373513743, 5858885.951630644500256 ], [ 1386716.173436045646667, 5859020.687923113815486 ], [ 1386623.407193717779592, 5859020.687923113815486 ], [ 1386530.640951389912516, 5859020.687923113815486 ], [ 1386437.87470906204544, 5859020.687923113815486 ], [ 1386345.108466734178364, 5859020.687923113815486 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "bedlev": 724.29998779296875, "branchid": "river_4", "width": 60.93007025, "height": 14.050003051757812, "branchorder": "1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_4", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386994.472163029015064, 5862120.19256996922195 ], [ 1386901.705920701380819, 5861985.408776419237256 ], [ 1386808.939678373513743, 5861850.62704914342612 ], [ 1386716.173436045646667, 5861715.847388052381575 ], [ 1386716.173436045646667, 5861581.069793050177395 ], [ 1386716.173436045646667, 5861446.294264047406614 ], [ 1386648.271799877518788, 5861347.644815167412162 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "bedlev": 724.29998779296875, "branchid": "river_4-1", "width": 60.93007025, "height": 14.050003051757812, "branchorder": "1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_4", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386648.271799877518788, 5861347.644815167412162 ], [ 1386623.407193717779592, 5861311.520800950936973 ], [ 1386623.407193717779592, 5861176.749403670430183 ], [ 1386530.640951389912516, 5861176.749403670430183 ], [ 1386437.87470906204544, 5861041.98007211368531 ], [ 1386437.87470906204544, 5860907.21280618570745 ], [ 1386437.87470906204544, 5860772.447605800814927 ], [ 1386437.87470906204544, 5860637.684470860287547 ], [ 1386345.108466734178364, 5860502.923401278443635 ], [ 1386345.108466734178364, 5860368.164396960288286 ], [ 1386252.342224406311288, 5860233.40745781455189 ], [ 1386159.575982078444213, 5860098.652583749964833 ], [ 1386159.575982078444213, 5859963.899774672463536 ], [ 1386159.575982078444213, 5859829.149030492641032 ], [ 1386159.575982078444213, 5859694.400351119227707 ], [ 1386252.342224406311288, 5859559.653736458159983 ], [ 1386252.342224406311288, 5859424.909186419099569 ], [ 1386252.342224406311288, 5859290.166700908914208 ], [ 1386252.342224406311288, 5859155.426279838196933 ], [ 1386345.108466734178364, 5859020.687923113815486 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "bedlev": 701.4000244140625, "branchid": "river_5", "width": 60.93007025, "height": 15.174972534179688, "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_5", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386345.108466734178364, 5859020.687923113815486 ], [ 1386252.342224406311288, 5858885.951630644500256 ], [ 1386159.575982078444213, 5858751.217402335256338 ], [ 1386159.575982078444213, 5858616.485238100402057 ], [ 1386159.575982078444213, 5858481.75513784494251 ], [ 1386159.575982078444213, 5858347.02710147574544 ], [ 1386066.809739750809968, 5858212.301128901541233 ], [ 1385974.043497422942892, 5858212.301128901541233 ], [ 1385881.277255095075816, 5858212.301128901541233 ], [ 1385788.51101276720874, 5858212.301128901541233 ], [ 1385695.744770439341664, 5858212.301128901541233 ], [ 1385602.978528111474589, 5858077.577220032922924 ], [ 1385510.212285783607513, 5857942.855374775826931 ], [ 1385510.212285783607513, 5857808.135593039914966 ], [ 1385417.446043455740437, 5857673.417874733917415 ], [ 1385324.679801127873361, 5857673.417874733917415 ], [ 1385231.913558800239116, 5857538.7022197637707 ], [ 1385231.913558800239116, 5857403.988628040067852 ], [ 1385231.913558800239116, 5857269.277099470607936 ], [ 1385231.913558800239116, 5857134.567633963190019 ], [ 1385324.679801127873361, 5856999.860231426544487 ], [ 1385231.913558800239116, 5856865.154891768470407 ], [ 1385231.913558800239116, 5856730.451614897698164 ], [ 1385139.14731647237204, 5856595.750400722026825 ], [ 1385046.381074144504964, 5856595.750400722026825 ], [ 1384953.614831816637889, 5856461.0512491511181 ], [ 1384860.848589488770813, 5856461.0512491511181 ], [ 1384768.082347160903737, 5856326.354160091839731 ], [ 1384768.082347160903737, 5856191.659133451990783 ], [ 1384675.316104833036661, 5856056.966169143095613 ], [ 1384582.549862505169585, 5856056.966169143095613 ], [ 1384489.78362017753534, 5855922.275267072021961 ], [ 1384397.017377849668264, 5855787.586427142843604 ], [ 1384304.251135521801189, 5855787.586427142843604 ], [ 1384211.484893193934113, 5855652.899649270810187 ], [ 1384118.718650866067037, 5855518.214933359995484 ] ] } } ] } diff --git a/examples/dflowfm_piave/geoms/manholes.geojson b/examples/dflowfm_piave/geoms/manholes.geojson index 5047fb16..780c04f8 100644 --- a/examples/dflowfm_piave/geoms/manholes.geojson +++ b/examples/dflowfm_piave/geoms/manholes.geojson @@ -2,1012 +2,1012 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::3857" } }, "features": [ -{ "type": "Feature", "properties": { "_index": 6, "bedlevel": 912.9000244140625, "branchid": "pipe_6_E0;pipe_7_E0;pipe_8_E0", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_0_generated", "shape": null, "area": 0.64, "streetlevel": 915.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 915.9000244140625, "distance_right": 2.8955455770766528e-07, "index_right": 7, "nodeid": "1389266.515512_5860111.688303", "id": "1389266.515512_5860111.688303", "name": "manhole_0_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389266.515512115787715, 5860111.688302734866738 ] } }, -{ "type": "Feature", "properties": { "_index": 6, "bedlevel": 912.9000244140625, "branchid": "pipe_6_E0;pipe_6_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_1_generated", "shape": null, "area": 0.64, "streetlevel": 915.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 915.9000244140625, "distance_right": 4.9863431599547954e-07, "index_right": 8, "nodeid": "1389238.298387_5860147.714495", "id": "1389238.298387_5860147.714495", "name": "manhole_1_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389238.298387300921604, 5860147.714495398104191 ] } }, -{ "type": "Feature", "properties": { "_index": 7, "bedlevel": 930.5, "branchid": "pipe_6_E1;pipe_6_E2", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_2_generated", "shape": null, "area": 0.64, "streetlevel": 933.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 933.5, "distance_right": 5.7008358445401274e-07, "index_right": 9, "nodeid": "1389210.947847_5860184.343885", "id": "1389210.947847_5860184.343885", "name": "manhole_2_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389210.947846550960094, 5860184.343885350972414 ] } }, -{ "type": "Feature", "properties": { "_index": 8, "bedlevel": 930.5, "branchid": "pipe_6_E2;pipe_6_E3", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_3_generated", "shape": null, "area": 0.64, "streetlevel": 933.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 933.5, "distance_right": 4.6075272516314234e-07, "index_right": 10, "nodeid": "1389186.961923_5860223.315261", "id": "1389186.961923_5860223.315261", "name": "manhole_3_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389186.961922727525234, 5860223.315261371433735 ] } }, -{ "type": "Feature", "properties": { "_index": 9, "bedlevel": 932.5, "branchid": "pipe_6_E3;pipe_6_E4", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_4_generated", "shape": null, "area": 0.64, "streetlevel": 935.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 935.5, "distance_right": 4.4283537640359513e-07, "index_right": 11, "nodeid": "1389162.755599_5860262.142883", "id": "1389162.755599_5860262.142883", "name": "manhole_4_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389162.755598766496405, 5860262.142883376218379 ] } }, -{ "type": "Feature", "properties": { "_index": 10, "bedlevel": 932.5, "branchid": "pipe_6_E4;pipe_6_E5", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_5_generated", "shape": null, "area": 0.64, "streetlevel": 935.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 935.5, "distance_right": 5.1403775599100041e-07, "index_right": 12, "nodeid": "1389136.759308_5860299.803015", "id": "1389136.759308_5860299.803015", "name": "manhole_5_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389136.759307563304901, 5860299.80301527120173 ] } }, -{ "type": "Feature", "properties": { "_index": 11, "bedlevel": 933.5, "branchid": "pipe_6_E5;pipe_6_E6", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_6_generated", "shape": null, "area": 0.64, "streetlevel": 936.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 936.5, "distance_right": 4.2800833621769655e-07, "index_right": 13, "nodeid": "1389109.730123_5860336.652257", "id": "1389109.730123_5860336.652257", "name": "manhole_6_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389109.7301227634307, 5860336.652257356792688 ] } }, -{ "type": "Feature", "properties": { "_index": 12, "bedlevel": 938.10003662109375, "branchid": "pipe_6_E6;pipe_6_E7", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_7_generated", "shape": null, "area": 0.64, "streetlevel": 941.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 941.10003662109375, "distance_right": 2.8647556573889729e-07, "index_right": 14, "nodeid": "1389073.184788_5860363.522737", "id": "1389073.184788_5860363.522737", "name": "manhole_7_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389073.18478828552179, 5860363.522737024351954 ] } }, -{ "type": "Feature", "properties": { "_index": 13, "bedlevel": 938.10003662109375, "branchid": "pipe_6_E7;pipe_6_E8", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_8_generated", "shape": null, "area": 0.64, "streetlevel": 941.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 941.10003662109375, "distance_right": 3.4023879020567642e-07, "index_right": 15, "nodeid": "1389032.546542_5860384.329287", "id": "1389032.546542_5860384.329287", "name": "manhole_8_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389032.546542100608349, 5860384.329287325032055 ] } }, -{ "type": "Feature", "properties": { "_index": 14, "bedlevel": 938.10003662109375, "branchid": "pipe_6_E8;pipe_6_E9", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_9_generated", "shape": null, "area": 0.64, "streetlevel": 941.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 941.10003662109375, "distance_right": 2.9931735352129969e-07, "index_right": 16, "nodeid": "1388989.578410_5860400.071979", "id": "1388989.578410_5860400.071979", "name": "manhole_9_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388989.578410296700895, 5860400.071978960186243 ] } }, -{ "type": "Feature", "properties": { "_index": 15, "bedlevel": 948.29998779296875, "branchid": "pipe_6_E9;pipe_7_E10;pipe_34_E0", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_10_generated", "shape": null, "area": 0.64, "streetlevel": 951.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 951.29998779296875, "distance_right": 3.4647202562053268e-07, "index_right": 17, "nodeid": "1388946.301101_5860414.883978", "id": "1388946.301101_5860414.883978", "name": "manhole_10_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388946.301100668497384, 5860414.883977899327874 ] } }, -{ "type": "Feature", "properties": { "_index": 16, "bedlevel": 912.9000244140625, "branchid": "pipe_7_E0;pipe_7_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_11_generated", "shape": null, "area": 0.64, "streetlevel": 915.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 915.9000244140625, "distance_right": 2.4635198559591233e-07, "index_right": 18, "nodeid": "1389221.905704_5860123.325637", "id": "1389221.905704_5860123.325637", "name": "manhole_11_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389221.905703959986567, 5860123.3256367566064 ] } }, -{ "type": "Feature", "properties": { "_index": 17, "bedlevel": 912.9000244140625, "branchid": "pipe_7_E1;pipe_7_E2", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_12_generated", "shape": null, "area": 0.64, "streetlevel": 915.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 915.9000244140625, "distance_right": 2.956036043959947e-07, "index_right": 19, "nodeid": "1389177.295896_5860134.962971", "id": "1389177.295896_5860134.962971", "name": "manhole_12_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389177.295895804418251, 5860134.962970778346062 ] } }, -{ "type": "Feature", "properties": { "_index": 18, "bedlevel": 916.60003662109375, "branchid": "pipe_7_E2;pipe_7_E3", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_13_generated", "shape": null, "area": 0.64, "streetlevel": 919.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 919.60003662109375, "distance_right": 4.043941204997758e-07, "index_right": 20, "nodeid": "1389132.686088_5860146.600305", "id": "1389132.686088_5860146.600305", "name": "manhole_13_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389132.686087648617104, 5860146.600304800085723 ] } }, -{ "type": "Feature", "properties": { "_index": 19, "bedlevel": 916.60003662109375, "branchid": "pipe_7_E3;pipe_7_E4", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_14_generated", "shape": null, "area": 0.64, "streetlevel": 919.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 919.60003662109375, "distance_right": 5.2423720860293592e-07, "index_right": 21, "nodeid": "1389088.076279_5860158.237639", "id": "1389088.076279_5860158.237639", "name": "manhole_14_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389088.076279493048787, 5860158.237638821825385 ] } }, -{ "type": "Feature", "properties": { "_index": 20, "bedlevel": 935.10003662109375, "branchid": "pipe_7_E4;pipe_7_E5", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_15_generated", "shape": null, "area": 0.64, "streetlevel": 938.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 938.10003662109375, "distance_right": 4.9176499718456295e-07, "index_right": 22, "nodeid": "1389044.226174_5860172.143309", "id": "1389044.226174_5860172.143309", "name": "manhole_15_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389044.226173994829878, 5860172.143308508209884 ] } }, -{ "type": "Feature", "properties": { "_index": 21, "bedlevel": 935.10003662109375, "branchid": "pipe_7_E5;pipe_7_E6", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_16_generated", "shape": null, "area": 0.64, "streetlevel": 938.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 938.10003662109375, "distance_right": 6.210052013844783e-07, "index_right": 23, "nodeid": "1389012.527182_5860198.239756", "id": "1389012.527182_5860198.239756", "name": "manhole_16_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389012.527182487538084, 5860198.239755615592003 ] } }, -{ "type": "Feature", "properties": { "_index": 22, "bedlevel": 935.10003662109375, "branchid": "pipe_7_E6;pipe_7_E7", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_17_generated", "shape": null, "area": 0.64, "streetlevel": 938.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 938.10003662109375, "distance_right": 4.0494336342938905e-07, "index_right": 24, "nodeid": "1388995.773123_5860240.481283", "id": "1388995.773123_5860240.481283", "name": "manhole_17_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388995.773122631013393, 5860240.481283166445792 ] } }, -{ "type": "Feature", "properties": { "_index": 23, "bedlevel": 942.0, "branchid": "pipe_7_E7;pipe_7_E8", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_18_generated", "shape": null, "area": 0.64, "streetlevel": 945.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 945.0, "distance_right": 3.6384956544063991e-07, "index_right": 25, "nodeid": "1388973.630034_5860280.918224", "id": "1388973.630034_5860280.918224", "name": "manhole_18_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388973.630034049740061, 5860280.918223639950156 ] } }, -{ "type": "Feature", "properties": { "_index": 24, "bedlevel": 948.29998779296875, "branchid": "pipe_7_E8;pipe_7_E9", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_19_generated", "shape": null, "area": 0.64, "streetlevel": 951.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 951.29998779296875, "distance_right": 1.818250807924088e-07, "index_right": 26, "nodeid": "1388961.171158_5860324.081193", "id": "1388961.171158_5860324.081193", "name": "manhole_19_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388961.171157888136804, 5860324.081192856654525 ] } }, -{ "type": "Feature", "properties": { "_index": 25, "bedlevel": 948.29998779296875, "branchid": "pipe_7_E9;pipe_7_E10", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_20_generated", "shape": null, "area": 0.64, "streetlevel": 951.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 951.29998779296875, "distance_right": 1.7347679874173417e-07, "index_right": 27, "nodeid": "1388955.410555_5860369.690169", "id": "1388955.410555_5860369.690169", "name": "manhole_20_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388955.410555170848966, 5860369.690168970264494 ] } }, -{ "type": "Feature", "properties": { "_index": 27, "bedlevel": 911.5, "branchid": "pipe_8_E0;pipe_8_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_21_generated", "shape": null, "area": 0.64, "streetlevel": 914.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 914.5, "distance_right": 1.6748600779980834e-07, "index_right": 28, "nodeid": "1389306.500000_5860083.476415", "id": "1389306.500000_5860083.476415", "name": "manhole_21_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389306.50000010849908, 5860083.476415127515793 ] } }, -{ "type": "Feature", "properties": { "_index": 28, "bedlevel": 911.5, "branchid": "pipe_8_E1;pipe_8_E2", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_22_generated", "shape": null, "area": 0.64, "streetlevel": 914.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 914.5, "distance_right": 5.0701945338922807e-07, "index_right": 29, "nodeid": "1389355.420758_5860074.630405", "id": "1389355.420758_5860074.630405", "name": "manhole_22_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389355.420758404070511, 5860074.630405306816101 ] } }, -{ "type": "Feature", "properties": { "_index": 29, "bedlevel": 926.9000244140625, "branchid": "pipe_8_E2;pipe_8_E3", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_23_generated", "shape": null, "area": 0.64, "streetlevel": 929.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 929.9000244140625, "distance_right": 2.1831036005702163e-07, "index_right": 30, "nodeid": "1389389.090761_5860042.444931", "id": "1389389.090761_5860042.444931", "name": "manhole_23_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389389.090761042200029, 5860042.4449307853356 ] } }, -{ "type": "Feature", "properties": { "_index": 30, "bedlevel": 952.0, "branchid": "pipe_8_E3;pipe_8_E4", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_24_generated", "shape": null, "area": 0.64, "streetlevel": 955.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 955.0, "distance_right": 4.281663745589639e-07, "index_right": 31, "nodeid": "1389404.036260_5859994.775434", "id": "1389404.036260_5859994.775434", "name": "manhole_24_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389404.036260401364416, 5859994.775433851405978 ] } }, -{ "type": "Feature", "properties": { "_index": 31, "bedlevel": 952.0, "branchid": "pipe_8_E4;pipe_8_E5", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_25_generated", "shape": null, "area": 0.64, "streetlevel": 955.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 955.0, "distance_right": 6.595190912537427e-07, "index_right": 32, "nodeid": "1389418.744130_5859947.032029", "id": "1389418.744130_5859947.032029", "name": "manhole_25_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389418.744130451697856, 5859947.032028519548476 ] } }, -{ "type": "Feature", "properties": { "_index": 32, "bedlevel": 952.0, "branchid": "pipe_8_E5;pipe_8_E6", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_26_generated", "shape": null, "area": 0.64, "streetlevel": 955.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 955.0, "distance_right": 3.6224026195323218e-07, "index_right": 33, "nodeid": "1389423.265343_5859897.853970", "id": "1389423.265343_5859897.853970", "name": "manhole_26_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389423.265342897269875, 5859897.853969652205706 ] } }, -{ "type": "Feature", "properties": { "_index": 33, "bedlevel": 972.29998779296875, "branchid": "pipe_8_E6;pipe_8_E7", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_27_generated", "shape": null, "area": 0.64, "streetlevel": 975.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 975.29998779296875, "distance_right": 5.241390138956655e-07, "index_right": 34, "nodeid": "1389395.831074_5859856.743155", "id": "1389395.831074_5859856.743155", "name": "manhole_27_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389395.831073811277747, 5859856.743154510855675 ] } }, -{ "type": "Feature", "properties": { "_index": 34, "bedlevel": 960.0, "branchid": "pipe_8_E7;pipe_8_E8", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_28_generated", "shape": null, "area": 0.64, "streetlevel": 963.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 963.0, "distance_right": 2.4446108841163454e-07, "index_right": 35, "nodeid": "1389350.827043_5859839.640479", "id": "1389350.827043_5859839.640479", "name": "manhole_28_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389350.827042841585353, 5859839.640478814020753 ] } }, -{ "type": "Feature", "properties": { "_index": 35, "bedlevel": 960.0, "branchid": "pipe_8_E8;pipe_8_E9", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_29_generated", "shape": null, "area": 0.64, "streetlevel": 963.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 963.0, "distance_right": 3.9835383960605792e-07, "index_right": 36, "nodeid": "1389303.795789_5859855.887689", "id": "1389303.795789_5859855.887689", "name": "manhole_29_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389303.795788601972163, 5859855.887689013034105 ] } }, -{ "type": "Feature", "properties": { "_index": 36, "bedlevel": 942.4000244140625, "branchid": "pipe_8_E9;pipe_8_E10", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_30_generated", "shape": null, "area": 0.64, "streetlevel": 945.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 945.4000244140625, "distance_right": 3.2789110600907463e-07, "index_right": 37, "nodeid": "1389256.284587_5859863.631581", "id": "1389256.284587_5859863.631581", "name": "manhole_30_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389256.284586790716276, 5859863.631580747663975 ] } }, -{ "type": "Feature", "properties": { "_index": 37, "bedlevel": 942.4000244140625, "branchid": "pipe_8_E10;pipe_8_E11", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_31_generated", "shape": null, "area": 0.64, "streetlevel": 945.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 945.4000244140625, "distance_right": 5.2000591108194085e-07, "index_right": 38, "nodeid": "1389227.308454_5859823.781623", "id": "1389227.308454_5859823.781623", "name": "manhole_31_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389227.308454349869862, 5859823.781623384915292 ] } }, -{ "type": "Feature", "properties": { "_index": 38, "bedlevel": 942.4000244140625, "branchid": "pipe_8_E11;pipe_8_E12", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_32_generated", "shape": null, "area": 0.64, "streetlevel": 945.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 945.4000244140625, "distance_right": 4.4402213892266013e-07, "index_right": 39, "nodeid": "1389202.745489_5859780.279728", "id": "1389202.745489_5859780.279728", "name": "manhole_32_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389202.745489193825051, 5859780.279727600514889 ] } }, -{ "type": "Feature", "properties": { "_index": 39, "bedlevel": 956.10003662109375, "branchid": "pipe_8_E12;pipe_8_E13", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_33_generated", "shape": null, "area": 0.64, "streetlevel": 959.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 959.10003662109375, "distance_right": 1.863954361493274e-07, "index_right": 40, "nodeid": "1389178.182524_5859736.777832", "id": "1389178.182524_5859736.777832", "name": "manhole_33_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389178.18252403778024, 5859736.777831817045808 ] } }, -{ "type": "Feature", "properties": { "_index": 40, "bedlevel": 941.79998779296875, "branchid": "pipe_8_E13;pipe_8_E14", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_34_generated", "shape": null, "area": 0.64, "streetlevel": 944.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 944.79998779296875, "distance_right": 4.7830062000180287e-07, "index_right": 41, "nodeid": "1389155.231297_5859692.450143", "id": "1389155.231297_5859692.450143", "name": "manhole_34_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389155.231297271326184, 5859692.450142606161535 ] } }, -{ "type": "Feature", "properties": { "_index": 41, "bedlevel": 941.79998779296875, "branchid": "pipe_8_E14;pipe_8_E15", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_35_generated", "shape": null, "area": 0.64, "streetlevel": 944.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 944.79998779296875, "distance_right": 4.9671720854496808e-07, "index_right": 42, "nodeid": "1389141.413413_5859644.883845", "id": "1389141.413413_5859644.883845", "name": "manhole_35_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389141.413412723457441, 5859644.883844587020576 ] } }, -{ "type": "Feature", "properties": { "_index": 42, "bedlevel": 949.4000244140625, "branchid": "pipe_8_E15;pipe_8_E16", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_36_generated", "shape": null, "area": 0.64, "streetlevel": 952.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 952.4000244140625, "distance_right": 2.2082179185505829e-07, "index_right": 43, "nodeid": "1389151.802280_5859598.618041", "id": "1389151.802280_5859598.618041", "name": "manhole_36_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389151.802280035568401, 5859598.61804121825844 ] } }, -{ "type": "Feature", "properties": { "_index": 43, "bedlevel": 957.70001220703125, "branchid": "pipe_8_E16;pipe_8_E17", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_37_generated", "shape": null, "area": 0.64, "streetlevel": 960.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 960.70001220703125, "distance_right": 3.7225134857209445e-07, "index_right": 44, "nodeid": "1389191.073855_5859569.046822", "id": "1389191.073855_5859569.046822", "name": "manhole_37_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389191.073854762827978, 5859569.046822287142277 ] } }, -{ "type": "Feature", "properties": { "_index": 44, "bedlevel": 957.70001220703125, "branchid": "pipe_8_E17;pipe_8_E18", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_38_generated", "shape": null, "area": 0.64, "streetlevel": 960.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 960.70001220703125, "distance_right": 4.2091375934231921e-07, "index_right": 45, "nodeid": "1389239.915166_5859563.955490", "id": "1389239.915166_5859563.955490", "name": "manhole_38_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389239.915165816899389, 5859563.955490378662944 ] } }, -{ "type": "Feature", "properties": { "_index": 45, "bedlevel": 966.60003662109375, "branchid": "pipe_8_E18;pipe_8_E19", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_39_generated", "shape": null, "area": 0.64, "streetlevel": 969.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 969.60003662109375, "distance_right": 4.8978984916104921e-07, "index_right": 46, "nodeid": "1389289.757686_5859566.285022", "id": "1389289.757686_5859566.285022", "name": "manhole_39_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389289.757686472963542, 5859566.285022127442062 ] } }, -{ "type": "Feature", "properties": { "_index": 46, "bedlevel": 966.60003662109375, "branchid": "pipe_8_E19;pipe_8_E20", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_40_generated", "shape": null, "area": 0.64, "streetlevel": 969.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 969.60003662109375, "distance_right": 4.5561762419406098e-07, "index_right": 47, "nodeid": "1389339.615828_5859566.079234", "id": "1389339.615828_5859566.079234", "name": "manhole_40_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389339.615828452631831, 5859566.079234052449465 ] } }, -{ "type": "Feature", "properties": { "_index": 47, "bedlevel": 973.29998779296875, "branchid": "pipe_8_E20;pipe_8_E21", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_41_generated", "shape": null, "area": 0.64, "streetlevel": 976.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 976.29998779296875, "distance_right": 3.0780959591952437e-07, "index_right": 48, "nodeid": "1389387.354308_5859551.676989", "id": "1389387.354308_5859551.676989", "name": "manhole_41_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389387.354307833593339, 5859551.676988741382957 ] } }, -{ "type": "Feature", "properties": { "_index": 48, "bedlevel": 973.29998779296875, "branchid": "pipe_8_E21;pipe_8_E22", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_42_generated", "shape": null, "area": 0.64, "streetlevel": 976.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 976.29998779296875, "distance_right": 2.2809906125236904e-07, "index_right": 49, "nodeid": "1389428.692969_5859524.248876", "id": "1389428.692969_5859524.248876", "name": "manhole_42_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389428.692968821851537, 5859524.248876142315567 ] } }, -{ "type": "Feature", "properties": { "_index": 49, "bedlevel": 963.79998779296875, "branchid": "pipe_8_E22;pipe_8_E23", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_43_generated", "shape": null, "area": 0.64, "streetlevel": 966.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 966.79998779296875, "distance_right": 4.7646645185690715e-07, "index_right": 50, "nodeid": "1389461.138922_5859486.477509", "id": "1389461.138922_5859486.477509", "name": "manhole_43_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389461.138921525795013, 5859486.477508954703808 ] } }, -{ "type": "Feature", "properties": { "_index": 50, "bedlevel": 963.79998779296875, "branchid": "pipe_8_E23;pipe_8_E24", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_44_generated", "shape": null, "area": 0.64, "streetlevel": 966.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 966.79998779296875, "distance_right": 4.8889384698940225e-07, "index_right": 51, "nodeid": "1389482.451638_5859441.487986", "id": "1389482.451638_5859441.487986", "name": "manhole_44_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389482.45163832209073, 5859441.487986368127167 ] } }, -{ "type": "Feature", "properties": { "_index": 51, "bedlevel": 963.79998779296875, "branchid": "pipe_8_E24;pipe_8_E25", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_45_generated", "shape": null, "area": 0.64, "streetlevel": 966.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 966.79998779296875, "distance_right": 2.3478981975380763e-07, "index_right": 52, "nodeid": "1389497.215460_5859393.906834", "id": "1389497.215460_5859393.906834", "name": "manhole_45_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389497.215460168197751, 5859393.906833835877478 ] } }, -{ "type": "Feature", "properties": { "_index": 52, "bedlevel": 954.29998779296875, "branchid": "pipe_8_E25;pipe_8_E26", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_46_generated", "shape": null, "area": 0.64, "streetlevel": 957.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 957.29998779296875, "distance_right": 5.2209295831122375e-07, "index_right": 53, "nodeid": "1389508.394423_5859345.216127", "id": "1389508.394423_5859345.216127", "name": "manhole_46_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389508.394423164660111, 5859345.216126504354179 ] } }, -{ "type": "Feature", "properties": { "_index": 53, "bedlevel": 954.29998779296875, "branchid": "pipe_8_E26;pipe_8_E27", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_47_generated", "shape": null, "area": 0.64, "streetlevel": 957.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 957.29998779296875, "distance_right": 3.0133898611394186e-07, "index_right": 54, "nodeid": "1389518.522438_5859296.296715", "id": "1389518.522438_5859296.296715", "name": "manhole_47_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389518.522437864448875, 5859296.29671473056078 ] } }, -{ "type": "Feature", "properties": { "_index": 54, "bedlevel": 954.29998779296875, "branchid": "pipe_8_E27;pipe_8_E28", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_48_generated", "shape": null, "area": 0.64, "streetlevel": 957.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 957.29998779296875, "distance_right": 5.4884780991796183e-07, "index_right": 55, "nodeid": "1389528.588072_5859247.363728", "id": "1389528.588072_5859247.363728", "name": "manhole_48_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389528.588071504374966, 5859247.363727764226496 ] } }, -{ "type": "Feature", "properties": { "_index": 55, "bedlevel": 947.20001220703125, "branchid": "pipe_8_E28;pipe_8_E29", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_49_generated", "shape": null, "area": 0.64, "streetlevel": 950.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 950.20001220703125, "distance_right": 2.4911616766346636e-07, "index_right": 56, "nodeid": "1389538.653705_5859198.430741", "id": "1389538.653705_5859198.430741", "name": "manhole_49_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389538.653705144301057, 5859198.43074079696089 ] } }, -{ "type": "Feature", "properties": { "_index": 56, "bedlevel": 954.60003662109375, "branchid": "pipe_8_E29;pipe_8_E30", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_50_generated", "shape": null, "area": 0.64, "streetlevel": 957.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 957.60003662109375, "distance_right": 2.7425236063129317e-07, "index_right": 57, "nodeid": "1389548.719339_5859149.497754", "id": "1389548.719339_5859149.497754", "name": "manhole_50_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389548.719338784459978, 5859149.497753830626607 ] } }, -{ "type": "Feature", "properties": { "_index": 57, "bedlevel": 954.60003662109375, "branchid": "pipe_8_E30;pipe_8_E31", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_51_generated", "shape": null, "area": 0.64, "streetlevel": 957.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 957.60003662109375, "distance_right": 4.4598301075309513e-07, "index_right": 58, "nodeid": "1389558.784972_5859100.564767", "id": "1389558.784972_5859100.564767", "name": "manhole_51_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389558.784972424386069, 5859100.564766863361001 ] } }, -{ "type": "Feature", "properties": { "_index": 58, "bedlevel": 951.79998779296875, "branchid": "pipe_8_E31;pipe_8_E32", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_52_generated", "shape": null, "area": 0.64, "streetlevel": 954.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 954.79998779296875, "distance_right": 1.2172211470524948e-07, "index_right": 59, "nodeid": "1389568.850606_5859051.631780", "id": "1389568.850606_5859051.631780", "name": "manhole_52_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389568.85060606431216, 5859051.631779897026718 ] } }, -{ "type": "Feature", "properties": { "_index": 59, "bedlevel": 951.79998779296875, "branchid": "pipe_8_E32;pipe_8_E33", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_53_generated", "shape": null, "area": 0.64, "streetlevel": 954.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 954.79998779296875, "distance_right": 3.0360624912949541e-07, "index_right": 60, "nodeid": "1389578.916240_5859002.698793", "id": "1389578.916240_5859002.698793", "name": "manhole_53_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389578.916239704471081, 5859002.698792929761112 ] } }, -{ "type": "Feature", "properties": { "_index": 60, "bedlevel": 951.79998779296875, "branchid": "pipe_8_E33;pipe_8_E34", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_54_generated", "shape": null, "area": 0.64, "streetlevel": 954.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 954.79998779296875, "distance_right": 3.4626676338146224e-07, "index_right": 61, "nodeid": "1389588.981873_5858953.765806", "id": "1389588.981873_5858953.765806", "name": "manhole_54_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389588.981873344397172, 5858953.765805963426828 ] } }, -{ "type": "Feature", "properties": { "_index": 61, "bedlevel": 953.10003662109375, "branchid": "pipe_8_E34;pipe_8_E35", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_55_generated", "shape": null, "area": 0.64, "streetlevel": 956.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 956.10003662109375, "distance_right": 1.6038296836702642e-08, "index_right": 62, "nodeid": "1389599.047507_5858904.832819", "id": "1389599.047507_5858904.832819", "name": "manhole_55_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389599.047506984323263, 5858904.832818996161222 ] } }, -{ "type": "Feature", "properties": { "_index": 62, "bedlevel": 953.10003662109375, "branchid": "pipe_8_E35;pipe_8_E36", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_56_generated", "shape": null, "area": 0.64, "streetlevel": 956.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 956.10003662109375, "distance_right": 1.9577623893350078e-07, "index_right": 63, "nodeid": "1389613.243874_5858857.048414", "id": "1389613.243874_5858857.048414", "name": "manhole_56_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389613.243873829254881, 5858857.048414096236229 ] } }, -{ "type": "Feature", "properties": { "_index": 63, "bedlevel": 963.29998779296875, "branchid": "pipe_8_E36;pipe_8_E37", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_57_generated", "shape": null, "area": 0.64, "streetlevel": 966.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 966.29998779296875, "distance_right": 2.8036406150556381e-07, "index_right": 64, "nodeid": "1389631.198101_5858810.554778", "id": "1389631.198101_5858810.554778", "name": "manhole_57_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389631.198101107496768, 5858810.554778259247541 ] } }, -{ "type": "Feature", "properties": { "_index": 64, "bedlevel": 965.70001220703125, "branchid": "pipe_8_E37;pipe_8_E38", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_58_generated", "shape": null, "area": 0.64, "streetlevel": 968.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 968.70001220703125, "distance_right": 2.7015138015241521e-07, "index_right": 65, "nodeid": "1389656.490606_5858767.472956", "id": "1389656.490606_5858767.472956", "name": "manhole_58_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389656.490605737781152, 5858767.472956065088511 ] } }, -{ "type": "Feature", "properties": { "_index": 65, "bedlevel": 965.70001220703125, "branchid": "pipe_8_E38;pipe_8_E39", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_59_generated", "shape": null, "area": 0.64, "streetlevel": 968.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 968.70001220703125, "distance_right": 7.4150254667243819e-08, "index_right": 66, "nodeid": "1389681.956975_5858724.496400", "id": "1389681.956975_5858724.496400", "name": "manhole_59_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389681.956975018838421, 5858724.49639992788434 ] } }, -{ "type": "Feature", "properties": { "_index": 66, "bedlevel": 973.10003662109375, "branchid": "pipe_8_E39;pipe_8_E40", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_60_generated", "shape": null, "area": 0.64, "streetlevel": 976.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 976.10003662109375, "distance_right": 3.7195414941973146e-07, "index_right": 67, "nodeid": "1389708.407580_5858682.115748", "id": "1389708.407580_5858682.115748", "name": "manhole_60_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389708.407580326776952, 5858682.115747822448611 ] } }, -{ "type": "Feature", "properties": { "_index": 67, "bedlevel": 980.10003662109375, "branchid": "pipe_8_E40;pipe_8_E41", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_61_generated", "shape": null, "area": 0.64, "streetlevel": 983.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 983.10003662109375, "distance_right": 4.6218008783908108e-07, "index_right": 68, "nodeid": "1389734.858186_5858639.735096", "id": "1389734.858186_5858639.735096", "name": "manhole_61_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389734.858185634715483, 5858639.735095717012882 ] } }, -{ "type": "Feature", "properties": { "_index": 68, "bedlevel": 980.10003662109375, "branchid": "pipe_8_E41;pipe_8_E42", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_62_generated", "shape": null, "area": 0.64, "streetlevel": 983.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 983.10003662109375, "distance_right": 3.9348378777503967e-07, "index_right": 69, "nodeid": "1389761.308791_5858597.354444", "id": "1389761.308791_5858597.354444", "name": "manhole_62_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389761.308790942654014, 5858597.354443610645831 ] } }, -{ "type": "Feature", "properties": { "_index": 69, "bedlevel": 980.10003662109375, "branchid": "pipe_8_E42;pipe_8_E43", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_63_generated", "shape": null, "area": 0.64, "streetlevel": 983.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 983.10003662109375, "distance_right": 5.5447458020309209e-07, "index_right": 70, "nodeid": "1389787.759396_5858554.973792", "id": "1389787.759396_5858554.973792", "name": "manhole_63_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389787.759396250825375, 5858554.973791505210102 ] } }, -{ "type": "Feature", "properties": { "_index": 70, "bedlevel": 990.29998779296875, "branchid": "pipe_8_E43;pipe_8_E44", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_64_generated", "shape": null, "area": 0.64, "streetlevel": 993.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 993.29998779296875, "distance_right": 5.9523102820972942e-07, "index_right": 71, "nodeid": "1389814.210002_5858512.593139", "id": "1389814.210002_5858512.593139", "name": "manhole_64_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389814.210001558763906, 5858512.593139399774373 ] } }, -{ "type": "Feature", "properties": { "_index": 71, "bedlevel": 995.29998779296875, "branchid": "pipe_8_E44;pipe_8_E45", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_65_generated", "shape": null, "area": 0.64, "streetlevel": 998.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 998.29998779296875, "distance_right": 3.2227739481136277e-07, "index_right": 72, "nodeid": "1389840.660607_5858470.212487", "id": "1389840.660607_5858470.212487", "name": "manhole_65_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389840.660606866702437, 5858470.212487293407321 ] } }, -{ "type": "Feature", "properties": { "_index": 72, "bedlevel": 995.29998779296875, "branchid": "pipe_8_E45;pipe_8_E46", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_66_generated", "shape": null, "area": 0.64, "streetlevel": 998.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 998.29998779296875, "distance_right": 2.5668076370860681e-07, "index_right": 73, "nodeid": "1389867.111212_5858427.831835", "id": "1389867.111212_5858427.831835", "name": "manhole_66_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389867.111212174640968, 5858427.831835187971592 ] } }, -{ "type": "Feature", "properties": { "_index": 73, "bedlevel": 995.29998779296875, "branchid": "pipe_8_E46;pipe_8_E47", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_67_generated", "shape": null, "area": 0.64, "streetlevel": 998.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 998.29998779296875, "distance_right": 1.2468597271427185e-07, "index_right": 74, "nodeid": "1389911.240854_5858417.074702", "id": "1389911.240854_5858417.074702", "name": "manhole_67_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389911.240854029776528, 5858417.074701879173517 ] } }, -{ "type": "Feature", "properties": { "_index": 74, "bedlevel": 1003.2000122070312, "branchid": "pipe_8_E47;pipe_8_E48", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_68_generated", "shape": null, "area": 0.64, "streetlevel": 1006.2000122070312, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1006.2000122070312, "distance_right": 3.2574538134795858e-07, "index_right": 75, "nodeid": "1389940.226093_5858455.739662", "id": "1389940.226093_5858455.739662", "name": "manhole_68_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389940.226093058940023, 5858455.739661679603159 ] } }, -{ "type": "Feature", "properties": { "_index": 75, "bedlevel": 1003.2000122070312, "branchid": "pipe_8_E48;pipe_8_E49", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_69_generated", "shape": null, "area": 0.64, "streetlevel": 1006.2000122070312, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1006.2000122070312, "distance_right": 4.546962510023651e-07, "index_right": 76, "nodeid": "1389959.842267_5858501.684845", "id": "1389959.842267_5858501.684845", "name": "manhole_69_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389959.842267287895083, 5858501.684845351614058 ] } }, -{ "type": "Feature", "properties": { "_index": 76, "bedlevel": 1003.2000122070312, "branchid": "pipe_8_E49;pipe_8_E50", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_70_generated", "shape": null, "area": 0.64, "streetlevel": 1006.2000122070312, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1006.2000122070312, "distance_right": 4.3064103079185693e-07, "index_right": 77, "nodeid": "1389983.028927_5858544.760825", "id": "1389983.028927_5858544.760825", "name": "manhole_70_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389983.028926897095516, 5858544.760824581608176 ] } }, -{ "type": "Feature", "properties": { "_index": 77, "bedlevel": 1033.9000244140625, "branchid": "pipe_8_E50;pipe_8_E51", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_71_generated", "shape": null, "area": 0.64, "streetlevel": 1036.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1036.9000244140625, "distance_right": 4.1431531026563027e-07, "index_right": 78, "nodeid": "1390026.879799_5858567.986969", "id": "1390026.879799_5858567.986969", "name": "manhole_71_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390026.879799408372492, 5858567.986969069577754 ] } }, -{ "type": "Feature", "properties": { "_index": 78, "bedlevel": 1033.9000244140625, "branchid": "pipe_8_E51;pipe_8_E52", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_72_generated", "shape": null, "area": 0.64, "streetlevel": 1036.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1036.9000244140625, "distance_right": 2.9937059585548104e-07, "index_right": 79, "nodeid": "1390075.455720_5858577.981818", "id": "1390075.455720_5858577.981818", "name": "manhole_72_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390075.455719914287329, 5858577.981817713007331 ] } }, -{ "type": "Feature", "properties": { "_index": 79, "bedlevel": 1029.9000244140625, "branchid": "pipe_8_E52;pipe_8_E53", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_73_generated", "shape": null, "area": 0.64, "streetlevel": 1032.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1032.9000244140625, "distance_right": 6.3999973011019791e-07, "index_right": 80, "nodeid": "1390124.934820_5858584.860858", "id": "1390124.934820_5858584.860858", "name": "manhole_73_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390124.934819511603564, 5858584.860858413390815 ] } }, -{ "type": "Feature", "properties": { "_index": 80, "bedlevel": 1029.9000244140625, "branchid": "pipe_8_E53;pipe_8_E54", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_74_generated", "shape": null, "area": 0.64, "streetlevel": 1032.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1032.9000244140625, "distance_right": 5.6459971675126326e-07, "index_right": 81, "nodeid": "1390174.385966_5858591.894069", "id": "1390174.385966_5858591.894069", "name": "manhole_74_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390174.385966305155307, 5858591.894069475121796 ] } }, -{ "type": "Feature", "properties": { "_index": 81, "bedlevel": 1013.6000366210938, "branchid": "pipe_8_E54;pipe_8_E55", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_75_generated", "shape": null, "area": 0.64, "streetlevel": 1016.6000366210938, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1016.6000366210938, "distance_right": 5.1654411025583547e-07, "index_right": 82, "nodeid": "1390224.287318_5858594.262458", "id": "1390224.287318_5858594.262458", "name": "manhole_75_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390224.28731826832518, 5858594.262458441779017 ] } }, -{ "type": "Feature", "properties": { "_index": 82, "bedlevel": 1013.6000366210938, "branchid": "pipe_8_E55;pipe_8_E56", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_76_generated", "shape": null, "area": 0.64, "streetlevel": 1016.6000366210938, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1016.6000366210938, "distance_right": 3.9007138584381877e-07, "index_right": 83, "nodeid": "1390273.630286_5858589.561946", "id": "1390273.630286_5858589.561946", "name": "manhole_76_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390273.630285855382681, 5858589.561945637688041 ] } }, -{ "type": "Feature", "properties": { "_index": 83, "bedlevel": 1009.1000366210938, "branchid": "pipe_8_E56;pipe_8_E57", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_77_generated", "shape": null, "area": 0.64, "streetlevel": 1012.1000366210938, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1012.1000366210938, "distance_right": 3.7797421488348324e-07, "index_right": 84, "nodeid": "1390322.239480_5858578.072307", "id": "1390322.239480_5858578.072307", "name": "manhole_77_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390322.239480242831632, 5858578.072306710295379 ] } }, -{ "type": "Feature", "properties": { "_index": 84, "bedlevel": 1009.1000366210938, "branchid": "pipe_8_E57;pipe_8_E58", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_78_generated", "shape": null, "area": 0.64, "streetlevel": 1012.1000366210938, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1012.1000366210938, "distance_right": 2.4273697310930584e-07, "index_right": 85, "nodeid": "1390371.993529_5858575.309523", "id": "1390371.993529_5858575.309523", "name": "manhole_78_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390371.99352877959609, 5858575.309522898867726 ] } }, -{ "type": "Feature", "properties": { "_index": 85, "bedlevel": 1008.7000122070312, "branchid": "pipe_8_E58;pipe_8_E59", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_79_generated", "shape": null, "area": 0.64, "streetlevel": 1011.7000122070312, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1011.7000122070312, "distance_right": 4.4565761900705597e-07, "index_right": 86, "nodeid": "1390419.135442_5858559.593115", "id": "1390419.135442_5858559.593115", "name": "manhole_79_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390419.13544210139662, 5858559.59311543405056 ] } }, -{ "type": "Feature", "properties": { "_index": 86, "bedlevel": 978.5, "branchid": "pipe_8_E59;pipe_8_E60", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_80_generated", "shape": null, "area": 0.64, "streetlevel": 981.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 981.5, "distance_right": 3.9297405447244982e-07, "index_right": 87, "nodeid": "1390453.401624_5858524.246224", "id": "1390453.401624_5858524.246224", "name": "manhole_80_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390453.401623640675098, 5858524.246223840862513 ] } }, -{ "type": "Feature", "properties": { "_index": 87, "bedlevel": 992.70001220703125, "branchid": "pipe_8_E60;pipe_8_E61", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_81_generated", "shape": null, "area": 0.64, "streetlevel": 995.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 995.70001220703125, "distance_right": 2.7019040680695823e-07, "index_right": 88, "nodeid": "1390496.749500_5858504.780009", "id": "1390496.749500_5858504.780009", "name": "manhole_81_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390496.749499944737181, 5858504.780008735135198 ] } }, -{ "type": "Feature", "properties": { "_index": 88, "bedlevel": 992.70001220703125, "branchid": "pipe_8_E61;pipe_8_E62", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_82_generated", "shape": null, "area": 0.64, "streetlevel": 995.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 995.70001220703125, "distance_right": 3.9802689654992729e-07, "index_right": 89, "nodeid": "1390546.470755_5858499.993152", "id": "1390546.470755_5858499.993152", "name": "manhole_82_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390546.470755147282034, 5858499.993151630274951 ] } }, -{ "type": "Feature", "properties": { "_index": 89, "bedlevel": 1002.9000244140625, "branchid": "pipe_8_E62;pipe_8_E63", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_83_generated", "shape": null, "area": 0.64, "streetlevel": 1005.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1005.9000244140625, "distance_right": 2.4497368864862642e-07, "index_right": 90, "nodeid": "1390596.395264_5858498.177226", "id": "1390596.395264_5858498.177226", "name": "manhole_83_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390596.395264241611585, 5858498.177226040512323 ] } }, -{ "type": "Feature", "properties": { "_index": 90, "bedlevel": 1002.9000244140625, "branchid": "pipe_8_E63;pipe_8_E64", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_84_generated", "shape": null, "area": 0.64, "streetlevel": 1005.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1005.9000244140625, "distance_right": 5.630813563551087e-07, "index_right": 91, "nodeid": "1390646.319773_5858496.361300", "id": "1390646.319773_5858496.361300", "name": "manhole_84_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390646.319773336173967, 5858496.361300451681018 ] } }, -{ "type": "Feature", "properties": { "_index": 91, "bedlevel": 1010.6000366210938, "branchid": "pipe_8_E64;pipe_8_E65", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_85_generated", "shape": null, "area": 0.64, "streetlevel": 1013.6000366210938, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1013.6000366210938, "distance_right": 4.5174815259276067e-07, "index_right": 92, "nodeid": "1390696.244282_5858494.545375", "id": "1390696.244282_5858494.545375", "name": "manhole_85_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390696.244282430503517, 5858494.545374862849712 ] } }, -{ "type": "Feature", "properties": { "_index": 92, "bedlevel": 1010.6000366210938, "branchid": "pipe_8_E65;pipe_8_E66", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_86_generated", "shape": null, "area": 0.64, "streetlevel": 1013.6000366210938, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1013.6000366210938, "distance_right": 5.4798189509202394e-07, "index_right": 93, "nodeid": "1390746.168792_5858492.729449", "id": "1390746.168792_5858492.729449", "name": "manhole_86_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390746.168791524833068, 5858492.729449273087084 ] } }, -{ "type": "Feature", "properties": { "_index": 93, "bedlevel": 1016.1000366210938, "branchid": "pipe_8_E66;pipe_8_E67", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_87_generated", "shape": null, "area": 0.64, "streetlevel": 1019.1000366210938, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1019.1000366210938, "distance_right": 4.9456434962347771e-07, "index_right": 94, "nodeid": "1390796.093301_5858490.913524", "id": "1390796.093301_5858490.913524", "name": "manhole_87_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390796.09330061939545, 5858490.913523684255779 ] } }, -{ "type": "Feature", "properties": { "_index": 94, "bedlevel": 1022.800048828125, "branchid": "pipe_8_E67;pipe_8_E68", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_88_generated", "shape": null, "area": 0.64, "streetlevel": 1025.800048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1025.800048828125, "distance_right": 3.0172587701371808e-07, "index_right": 95, "nodeid": "1390846.017810_5858489.097598", "id": "1390846.017810_5858489.097598", "name": "manhole_88_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390846.017809713725001, 5858489.097598095424473 ] } }, -{ "type": "Feature", "properties": { "_index": 95, "bedlevel": 1022.800048828125, "branchid": "pipe_8_E68;pipe_8_E69", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_89_generated", "shape": null, "area": 0.64, "streetlevel": 1025.800048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1025.800048828125, "distance_right": 5.3044278269972165e-07, "index_right": 96, "nodeid": "1390895.942319_5858487.281673", "id": "1390895.942319_5858487.281673", "name": "manhole_89_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390895.942318808054551, 5858487.281672505661845 ] } }, -{ "type": "Feature", "properties": { "_index": 96, "bedlevel": 1026.2000732421875, "branchid": "pipe_8_E69;pipe_8_E70", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_90_generated", "shape": null, "area": 0.64, "streetlevel": 1029.2000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1029.2000732421875, "distance_right": 3.6479034128509556e-07, "index_right": 97, "nodeid": "1390945.364988_5858492.061226", "id": "1390945.364988_5858492.061226", "name": "manhole_90_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390945.364988021552563, 5858492.061225635930896 ] } }, -{ "type": "Feature", "properties": { "_index": 97, "bedlevel": 1026.2000732421875, "branchid": "pipe_8_E70;pipe_8_E71", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_91_generated", "shape": null, "area": 0.64, "streetlevel": 1029.2000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1029.2000732421875, "distance_right": 4.3568107187541058e-07, "index_right": 98, "nodeid": "1390994.440002_5858501.409873", "id": "1390994.440002_5858501.409873", "name": "manhole_91_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390994.440001817885786, 5858501.409873396158218 ] } }, -{ "type": "Feature", "properties": { "_index": 98, "bedlevel": 1030.2000732421875, "branchid": "pipe_8_E71;pipe_8_E72", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_92_generated", "shape": null, "area": 0.64, "streetlevel": 1033.2000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1033.2000732421875, "distance_right": 2.741891005169924e-07, "index_right": 99, "nodeid": "1391040.341197_5858520.979841", "id": "1391040.341197_5858520.979841", "name": "manhole_92_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391040.341196772176772, 5858520.979841153137386 ] } }, -{ "type": "Feature", "properties": { "_index": 99, "bedlevel": 1030.2000732421875, "branchid": "pipe_8_E72;pipe_8_E73", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_93_generated", "shape": null, "area": 0.64, "streetlevel": 1033.2000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1033.2000732421875, "distance_right": 8.732235612425121e-08, "index_right": 100, "nodeid": "1391086.683747_5858538.717575", "id": "1391086.683747_5858538.717575", "name": "manhole_93_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391086.683747049886733, 5858538.717575071379542 ] } }, -{ "type": "Feature", "properties": { "_index": 100, "bedlevel": 1035.2000732421875, "branchid": "pipe_8_E73;pipe_8_E74", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_94_generated", "shape": null, "area": 0.64, "streetlevel": 1038.2000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1038.2000732421875, "distance_right": 2.5924414027713618e-07, "index_right": 101, "nodeid": "1391131.822940_5858523.932432", "id": "1391131.822940_5858523.932432", "name": "manhole_94_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391131.822940095094964, 5858523.93243224080652 ] } }, -{ "type": "Feature", "properties": { "_index": 101, "bedlevel": 1035.2000732421875, "branchid": "pipe_8_E74;pipe_8_E75", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_95_generated", "shape": null, "area": 0.64, "streetlevel": 1038.2000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1038.2000732421875, "distance_right": 1.3213318521127537e-07, "index_right": 102, "nodeid": "1391153.157672_5858479.460671", "id": "1391153.157672_5858479.460671", "name": "manhole_95_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391153.157672074623406, 5858479.460670891217887 ] } }, -{ "type": "Feature", "properties": { "_index": 102, "bedlevel": 1035.2000732421875, "branchid": "pipe_8_E75;pipe_8_E76", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_96_generated", "shape": null, "area": 0.64, "streetlevel": 1038.2000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1038.2000732421875, "distance_right": 6.7824090023605347e-08, "index_right": 103, "nodeid": "1391192.495906_5858451.678392", "id": "1391192.495906_5858451.678392", "name": "manhole_96_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391192.49590603238903, 5858451.67839205916971 ] } }, -{ "type": "Feature", "properties": { "_index": 103, "bedlevel": 1041.2000732421875, "branchid": "pipe_8_E76;pipe_8_E77", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_97_generated", "shape": null, "area": 0.64, "streetlevel": 1044.2000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1044.2000732421875, "distance_right": 4.4386974600926325e-07, "index_right": 104, "nodeid": "1391240.641174_5858438.460245", "id": "1391240.641174_5858438.460245", "name": "manhole_97_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391240.64117361814715, 5858438.460245226509869 ] } }, -{ "type": "Feature", "properties": { "_index": 104, "bedlevel": 1041.2000732421875, "branchid": "pipe_8_E77;pipe_8_E78", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_98_generated", "shape": null, "area": 0.64, "streetlevel": 1044.2000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1044.2000732421875, "distance_right": 4.0992187190293211e-07, "index_right": 105, "nodeid": "1391289.211760_5858426.770406", "id": "1391289.211760_5858426.770406", "name": "manhole_98_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391289.211760010803118, 5858426.770406410098076 ] } }, -{ "type": "Feature", "properties": { "_index": 105, "bedlevel": 1057.0999755859375, "branchid": "pipe_8_E78;pipe_8_E79", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_99_generated", "shape": null, "area": 0.64, "streetlevel": 1060.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1060.0999755859375, "distance_right": 5.7227858761127112e-07, "index_right": 106, "nodeid": "1391337.782346_5858415.080568", "id": "1391337.782346_5858415.080568", "name": "manhole_99_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391337.782346403226256, 5858415.080567593686283 ] } }, -{ "type": "Feature", "properties": { "_index": 106, "bedlevel": 1020.0, "branchid": "pipe_8_E79;pipe_8_E80", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_100_generated", "shape": null, "area": 0.64, "streetlevel": 1023.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1023.0, "distance_right": 3.0205816736469116e-07, "index_right": 107, "nodeid": "1391386.352933_5858403.390729", "id": "1391386.352933_5858403.390729", "name": "manhole_100_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391386.352932795882225, 5858403.390728777274489 ] } }, -{ "type": "Feature", "properties": { "_index": 107, "bedlevel": 1029.7000732421875, "branchid": "pipe_8_E80;pipe_8_E81", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_101_generated", "shape": null, "area": 0.64, "streetlevel": 1032.7000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1032.7000732421875, "distance_right": 1.9219136604978585e-07, "index_right": 108, "nodeid": "1391434.923519_5858391.700890", "id": "1391434.923519_5858391.700890", "name": "manhole_101_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391434.923519188305363, 5858391.700889961794019 ] } }, -{ "type": "Feature", "properties": { "_index": 108, "bedlevel": 1029.7000732421875, "branchid": "pipe_8_E81;pipe_8_E82", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_102_generated", "shape": null, "area": 0.64, "streetlevel": 1032.7000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1032.7000732421875, "distance_right": 4.4356382539420129e-07, "index_right": 109, "nodeid": "1391483.494106_5858380.011051", "id": "1391483.494106_5858380.011051", "name": "manhole_102_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391483.494105580961332, 5858380.011051145382226 ] } }, -{ "type": "Feature", "properties": { "_index": 109, "bedlevel": 1037.7000732421875, "branchid": "pipe_8_E82;pipe_8_E83", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_103_generated", "shape": null, "area": 0.64, "streetlevel": 1040.7000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1040.7000732421875, "distance_right": 3.7088810712096512e-07, "index_right": 110, "nodeid": "1391532.464345_5858375.802092", "id": "1391532.464345_5858375.802092", "name": "manhole_103_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391532.464345134794712, 5858375.802092345431447 ] } }, -{ "type": "Feature", "properties": { "_index": 110, "bedlevel": 1037.7000732421875, "branchid": "pipe_8_E83;pipe_8_E84", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_104_generated", "shape": null, "area": 0.64, "streetlevel": 1040.7000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1040.7000732421875, "distance_right": 4.6015352769437255e-07, "index_right": 111, "nodeid": "1391579.680509_5858389.753166", "id": "1391579.680509_5858389.753166", "name": "manhole_104_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391579.680508555145934, 5858389.753166117705405 ] } }, -{ "type": "Feature", "properties": { "_index": 111, "bedlevel": 1091.5999755859375, "branchid": "pipe_8_E84;pipe_8_E85", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_105_generated", "shape": null, "area": 0.64, "streetlevel": 1094.5999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1094.5999755859375, "distance_right": 3.7281072118280933e-07, "index_right": 112, "nodeid": "1391615.043222_5858422.374544", "id": "1391615.043222_5858422.374544", "name": "manhole_105_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391615.043221722124144, 5858422.374543751589954 ] } }, -{ "type": "Feature", "properties": { "_index": 112, "bedlevel": 1091.5999755859375, "branchid": "pipe_8_E85;pipe_8_E86", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_106_generated", "shape": null, "area": 0.64, "streetlevel": 1094.5999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1094.5999755859375, "distance_right": 2.2872503157110954e-07, "index_right": 113, "nodeid": "1391633.654096_5858468.206738", "id": "1391633.654096_5858468.206738", "name": "manhole_106_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391633.654095822479576, 5858468.206737855449319 ] } }, -{ "type": "Feature", "properties": { "_index": 113, "bedlevel": 1091.5999755859375, "branchid": "pipe_8_E86;pipe_8_E87", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_107_generated", "shape": null, "area": 0.64, "streetlevel": 1094.5999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1094.5999755859375, "distance_right": 9.072182616041515e-08, "index_right": 114, "nodeid": "1391675.556872_5858492.042519", "id": "1391675.556872_5858492.042519", "name": "manhole_107_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391675.556871910346672, 5858492.042518986389041 ] } }, -{ "type": "Feature", "properties": { "_index": 114, "bedlevel": 1097.5999755859375, "branchid": "pipe_8_E87;pipe_8_E88", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_108_generated", "shape": null, "area": 0.64, "streetlevel": 1100.5999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1100.5999755859375, "distance_right": 4.4979023780430931e-07, "index_right": 115, "nodeid": "1391725.165285_5858493.223411", "id": "1391725.165285_5858493.223411", "name": "manhole_108_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391725.165284683462232, 5858493.223410680890083 ] } }, -{ "type": "Feature", "properties": { "_index": 115, "bedlevel": 1089.7000732421875, "branchid": "pipe_8_E88;pipe_8_E89", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_109_generated", "shape": null, "area": 0.64, "streetlevel": 1092.7000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1092.7000732421875, "distance_right": 6.1507933656501941e-07, "index_right": 116, "nodeid": "1391774.025633_5858482.968163", "id": "1391774.025633_5858482.968163", "name": "manhole_109_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391774.025632579578087, 5858482.968163449317217 ] } }, -{ "type": "Feature", "properties": { "_index": 116, "bedlevel": 1089.7000732421875, "branchid": "pipe_8_E89;pipe_8_E90", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_110_generated", "shape": null, "area": 0.64, "streetlevel": 1092.7000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1092.7000732421875, "distance_right": 4.4649032319595157e-07, "index_right": 117, "nodeid": "1391822.748904_5858472.800456", "id": "1391822.748904_5858472.800456", "name": "manhole_110_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391822.748904443578795, 5858472.800456050783396 ] } }, -{ "type": "Feature", "properties": { "_index": 117, "bedlevel": 1083.5, "branchid": "pipe_8_E90;pipe_8_E91", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_111_generated", "shape": null, "area": 0.64, "streetlevel": 1086.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1086.5, "distance_right": 5.1775132957041802e-07, "index_right": 118, "nodeid": "1391872.520156_5858474.254767", "id": "1391872.520156_5858474.254767", "name": "manhole_111_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391872.520155652426183, 5858474.254766616038978 ] } }, -{ "type": "Feature", "properties": { "_index": 118, "bedlevel": 1083.5, "branchid": "pipe_8_E91;pipe_8_E92", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_112_generated", "shape": null, "area": 0.64, "streetlevel": 1086.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1086.5, "distance_right": 4.4541475797890906e-07, "index_right": 119, "nodeid": "1391922.328207_5858478.116395", "id": "1391922.328207_5858478.116395", "name": "manhole_112_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391922.32820742437616, 5858478.116394865326583 ] } }, -{ "type": "Feature", "properties": { "_index": 119, "bedlevel": 1094.300048828125, "branchid": "pipe_8_E92;pipe_8_E93", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_113_generated", "shape": null, "area": 0.64, "streetlevel": 1097.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1097.300048828125, "distance_right": 2.2746016721836874e-07, "index_right": 120, "nodeid": "1391972.136259_5858481.978023", "id": "1391972.136259_5858481.978023", "name": "manhole_113_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391972.136259196558967, 5858481.978023114614189 ] } }, -{ "type": "Feature", "properties": { "_index": 120, "bedlevel": 1094.300048828125, "branchid": "pipe_8_E93;pipe_8_E94", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_114_generated", "shape": null, "area": 0.64, "streetlevel": 1097.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1097.300048828125, "distance_right": 3.2100414121190839e-07, "index_right": 121, "nodeid": "1392014.088138_5858507.265421", "id": "1392014.088138_5858507.265421", "name": "manhole_114_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392014.088137687649578, 5858507.265420926734805 ] } }, -{ "type": "Feature", "properties": { "_index": 121, "bedlevel": 1094.300048828125, "branchid": "pipe_8_E94;pipe_8_E95", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_115_generated", "shape": null, "area": 0.64, "streetlevel": 1097.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1097.300048828125, "distance_right": 2.1114543171142478e-07, "index_right": 122, "nodeid": "1392052.005776_5858538.949621", "id": "1392052.005776_5858538.949621", "name": "manhole_115_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392052.00577615830116, 5858538.949620860628784 ] } }, -{ "type": "Feature", "properties": { "_index": 122, "bedlevel": 1094.300048828125, "branchid": "pipe_8_E95;pipe_8_E96", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_116_generated", "shape": null, "area": 0.64, "streetlevel": 1097.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1097.300048828125, "distance_right": 5.0401854604332595e-07, "index_right": 123, "nodeid": "1392100.993319_5858548.746294", "id": "1392100.993319_5858548.746294", "name": "manhole_116_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392100.993319420609623, 5858548.746293722651899 ] } }, -{ "type": "Feature", "properties": { "_index": 123, "bedlevel": 1132.300048828125, "branchid": "pipe_8_E96;pipe_8_E97", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_117_generated", "shape": null, "area": 0.64, "streetlevel": 1135.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1135.300048828125, "distance_right": 5.2170281845336017e-07, "index_right": 124, "nodeid": "1392149.980863_5858558.542967", "id": "1392149.980863_5858558.542967", "name": "manhole_117_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392149.980862683150917, 5858558.542966585606337 ] } }, -{ "type": "Feature", "properties": { "_index": 124, "bedlevel": 1132.300048828125, "branchid": "pipe_8_E97;pipe_8_E98", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_118_generated", "shape": null, "area": 0.64, "streetlevel": 1135.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1135.300048828125, "distance_right": 4.4445564759065617e-07, "index_right": 125, "nodeid": "1392198.767288_5858569.252067", "id": "1392198.767288_5858569.252067", "name": "manhole_118_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392198.767287699971348, 5858569.25206732749939 ] } }, -{ "type": "Feature", "properties": { "_index": 125, "bedlevel": 1134.5999755859375, "branchid": "pipe_8_E98;pipe_8_E99", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_119_generated", "shape": null, "area": 0.64, "streetlevel": 1137.5999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1137.5999755859375, "distance_right": 4.7301835974406382e-07, "index_right": 126, "nodeid": "1392247.333907_5858580.958378", "id": "1392247.333907_5858580.958378", "name": "manhole_119_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392247.333906656363979, 5858580.958378325216472 ] } }, -{ "type": "Feature", "properties": { "_index": 126, "bedlevel": 1134.5999755859375, "branchid": "pipe_8_E99;pipe_8_E100", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_120_generated", "shape": null, "area": 0.64, "streetlevel": 1137.5999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1137.5999755859375, "distance_right": 5.0475986687146605e-07, "index_right": 127, "nodeid": "1392295.900526_5858592.664689", "id": "1392295.900526_5858592.664689", "name": "manhole_120_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392295.900525612989441, 5858592.664689323864877 ] } }, -{ "type": "Feature", "properties": { "_index": 127, "bedlevel": 1142.0999755859375, "branchid": "pipe_8_E100;pipe_8_E101", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_121_generated", "shape": null, "area": 0.64, "streetlevel": 1145.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1145.0999755859375, "distance_right": 5.375595191494766e-07, "index_right": 128, "nodeid": "1392344.467145_5858604.371000", "id": "1392344.467145_5858604.371000", "name": "manhole_121_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392344.467144569614902, 5858604.371000322513282 ] } }, -{ "type": "Feature", "properties": { "_index": 128, "bedlevel": 1142.0999755859375, "branchid": "pipe_8_E101;pipe_8_E102", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_122_generated", "shape": null, "area": 0.64, "streetlevel": 1145.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1145.0999755859375, "distance_right": 2.4497368864862642e-07, "index_right": 129, "nodeid": "1392389.908256_5858624.575614", "id": "1392389.908256_5858624.575614", "name": "manhole_122_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392389.908255772199482, 5858624.575613909401 ] } }, -{ "type": "Feature", "properties": { "_index": 129, "bedlevel": 1137.5, "branchid": "pipe_8_E102;pipe_8_E103", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_123_generated", "shape": null, "area": 0.64, "streetlevel": 1140.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1140.5, "distance_right": 6.1951662367235888e-07, "index_right": 130, "nodeid": "1392425.081700_5858659.315580", "id": "1392425.081700_5858659.315580", "name": "manhole_123_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392425.081700494978577, 5858659.315580372698605 ] } }, -{ "type": "Feature", "properties": { "_index": 130, "bedlevel": 1166.300048828125, "branchid": "pipe_8_E103;pipe_8_E104", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_124_generated", "shape": null, "area": 0.64, "streetlevel": 1169.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1169.300048828125, "distance_right": 4.961599164442623e-07, "index_right": 131, "nodeid": "1392458.203119_5858696.715123", "id": "1392458.203119_5858696.715123", "name": "manhole_124_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392458.203119478421286, 5858696.715123130939901 ] } }, -{ "type": "Feature", "properties": { "_index": 131, "bedlevel": 1166.300048828125, "branchid": "pipe_8_E104;pipe_8_E105", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_125_generated", "shape": null, "area": 0.64, "streetlevel": 1169.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1169.300048828125, "distance_right": 4.7482840076464003e-07, "index_right": 132, "nodeid": "1392491.324538_5858734.114666", "id": "1392491.324538_5858734.114666", "name": "manhole_125_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392491.324538461863995, 5858734.114665890112519 ] } }, -{ "type": "Feature", "properties": { "_index": 132, "bedlevel": 1162.5, "branchid": "pipe_8_E105;pipe_8_E106", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_126_generated", "shape": null, "area": 0.64, "streetlevel": 1165.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1165.5, "distance_right": 3.1541772764253496e-07, "index_right": 133, "nodeid": "1392528.963966_5858766.460637", "id": "1392528.963966_5858766.460637", "name": "manhole_126_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392528.963966277893633, 5858766.460637149401009 ] } }, -{ "type": "Feature", "properties": { "_index": 133, "bedlevel": 1162.5, "branchid": "pipe_8_E106;pipe_8_E107", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_127_generated", "shape": null, "area": 0.64, "streetlevel": 1165.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1165.5, "distance_right": 2.530020739658982e-07, "index_right": 134, "nodeid": "1392573.284122_5858789.391093", "id": "1392573.284122_5858789.391093", "name": "manhole_127_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392573.284122244687751, 5858789.391092935577035 ] } }, -{ "type": "Feature", "properties": { "_index": 134, "bedlevel": 1154.0999755859375, "branchid": "pipe_8_E107;pipe_8_E108", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_128_generated", "shape": null, "area": 0.64, "streetlevel": 1157.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1157.0999755859375, "distance_right": 4.2339034603252275e-07, "index_right": 135, "nodeid": "1392618.033192_5858811.600886", "id": "1392618.033192_5858811.600886", "name": "manhole_128_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392618.033192394766957, 5858811.600886153057218 ] } }, -{ "type": "Feature", "properties": { "_index": 135, "bedlevel": 1181.800048828125, "branchid": "pipe_8_E108;pipe_8_E109", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_129_generated", "shape": null, "area": 0.64, "streetlevel": 1184.800048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1184.800048828125, "distance_right": 1.9266352396909839e-07, "index_right": 136, "nodeid": "1392666.730896_5858821.011834", "id": "1392666.730896_5858821.011834", "name": "manhole_129_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392666.730896146036685, 5858821.011833874508739 ] } }, -{ "type": "Feature", "properties": { "_index": 136, "bedlevel": 1138.2000732421875, "branchid": "pipe_8_E109;pipe_8_E110", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_130_generated", "shape": null, "area": 0.64, "streetlevel": 1141.2000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1141.2000732421875, "distance_right": 2.6027935522375354e-07, "index_right": 137, "nodeid": "1392714.397227_5858809.184478", "id": "1392714.397227_5858809.184478", "name": "manhole_130_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392714.397227015113458, 5858809.184477739967406 ] } }, -{ "type": "Feature", "properties": { "_index": 137, "bedlevel": 1138.2000732421875, "branchid": "pipe_8_E110;pipe_8_E111", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_131_generated", "shape": null, "area": 0.64, "streetlevel": 1141.2000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1141.2000732421875, "distance_right": 1.8147785838056748e-07, "index_right": 138, "nodeid": "1392761.799295_5858794.231294", "id": "1392761.799295_5858794.231294", "name": "manhole_131_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392761.799294820055366, 5858794.231293976306915 ] } }, -{ "type": "Feature", "properties": { "_index": 138, "bedlevel": 1134.4000244140625, "branchid": "pipe_8_E111;pipe_8_E112", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_132_generated", "shape": null, "area": 0.64, "streetlevel": 1137.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1137.4000244140625, "distance_right": 2.5613275709078171e-07, "index_right": 139, "nodeid": "1392810.095713_5858797.830353", "id": "1392810.095713_5858797.830353", "name": "manhole_132_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392810.095712865469977, 5858797.830352782271802 ] } }, -{ "type": "Feature", "properties": { "_index": 139, "bedlevel": 1134.4000244140625, "branchid": "pipe_8_E112;pipe_8_E113", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_133_generated", "shape": null, "area": 0.64, "streetlevel": 1137.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1137.4000244140625, "distance_right": 2.0095334863222291e-07, "index_right": 140, "nodeid": "1392855.660074_5858817.529771", "id": "1392855.660074_5858817.529771", "name": "manhole_133_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392855.660074200481176, 5858817.529770986177027 ] } }, -{ "type": "Feature", "properties": { "_index": 140, "bedlevel": 1166.5, "branchid": "pipe_8_E113;pipe_8_E114", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_134_generated", "shape": null, "area": 0.64, "streetlevel": 1169.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1169.5, "distance_right": 1.7695128917694092e-07, "index_right": 141, "nodeid": "1392904.672455_5858826.347065", "id": "1392904.672455_5858826.347065", "name": "manhole_134_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392904.672455, 5858826.347064822912216 ] } }, -{ "type": "Feature", "properties": { "_index": 141, "bedlevel": 1166.5, "branchid": "pipe_8_E114;pipe_8_E115", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_135_generated", "shape": null, "area": 0.64, "streetlevel": 1169.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1169.5, "distance_right": 4.2239046795471208e-07, "index_right": 142, "nodeid": "1392949.505033_5858846.393358", "id": "1392949.505033_5858846.393358", "name": "manhole_135_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392949.505032581742853, 5858846.393358059227467 ] } }, -{ "type": "Feature", "properties": { "_index": 142, "bedlevel": 1166.5, "branchid": "pipe_8_E115;pipe_8_E116", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_136_generated", "shape": null, "area": 0.64, "streetlevel": 1169.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1169.5, "distance_right": 4.7343585218773503e-07, "index_right": 143, "nodeid": "1392993.956313_5858868.358838", "id": "1392993.956313_5858868.358838", "name": "manhole_136_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392993.956312821945176, 5858868.358838438987732 ] } }, -{ "type": "Feature", "properties": { "_index": 143, "bedlevel": 1166.5, "branchid": "pipe_8_E116;pipe_8_E117", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_137_generated", "shape": null, "area": 0.64, "streetlevel": 1169.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1169.5, "distance_right": 3.5917098364593396e-07, "index_right": 144, "nodeid": "1393042.160067_5858881.479520", "id": "1393042.160067_5858881.479520", "name": "manhole_137_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393042.160067020915449, 5858881.479519641026855 ] } }, -{ "type": "Feature", "properties": { "_index": 144, "bedlevel": 1159.0, "branchid": "pipe_8_E117;pipe_8_E118", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_138_generated", "shape": null, "area": 0.64, "streetlevel": 1162.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1162.0, "distance_right": 2.7014626312928133e-07, "index_right": 145, "nodeid": "1393090.363821_5858894.600201", "id": "1393090.363821_5858894.600201", "name": "manhole_138_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393090.363821219652891, 5858894.600200843065977 ] } }, -{ "type": "Feature", "properties": { "_index": 145, "bedlevel": 1159.0, "branchid": "pipe_8_E118;pipe_8_E119", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_139_generated", "shape": null, "area": 0.64, "streetlevel": 1162.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1162.0, "distance_right": 2.7132603156118906e-07, "index_right": 146, "nodeid": "1393138.877780_5858905.382868", "id": "1393138.877780_5858905.382868", "name": "manhole_139_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393138.877780271228403, 5858905.382868006825447 ] } }, -{ "type": "Feature", "properties": { "_index": 146, "bedlevel": 1149.0999755859375, "branchid": "pipe_8_E119;pipe_8_E120", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_140_generated", "shape": null, "area": 0.64, "streetlevel": 1152.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1152.0999755859375, "distance_right": 4.4714856881835964e-07, "index_right": 147, "nodeid": "1393188.835210_5858905.286093", "id": "1393188.835210_5858905.286093", "name": "manhole_140_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393188.835210436256602, 5858905.286093098111451 ] } }, -{ "type": "Feature", "properties": { "_index": 147, "bedlevel": 1149.0999755859375, "branchid": "pipe_8_E120;pipe_8_E121", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_141_generated", "shape": null, "area": 0.64, "streetlevel": 1152.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1152.0999755859375, "distance_right": 4.1288226393878735e-07, "index_right": 148, "nodeid": "1393237.248238_5858916.599204", "id": "1393237.248238_5858916.599204", "name": "manhole_141_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393237.248238409170881, 5858916.599204055964947 ] } }, -{ "type": "Feature", "properties": { "_index": 148, "bedlevel": 1144.300048828125, "branchid": "pipe_8_E121;pipe_8_E122", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_142_generated", "shape": null, "area": 0.64, "streetlevel": 1147.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1147.300048828125, "distance_right": 5.0644962812498666e-07, "index_right": 149, "nodeid": "1393278.156388_5858943.766048", "id": "1393278.156388_5858943.766048", "name": "manhole_142_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393278.15638761385344, 5858943.766047672368586 ] } }, -{ "type": "Feature", "properties": { "_index": 149, "bedlevel": 1179.7000732421875, "branchid": "pipe_8_E122;pipe_8_E123", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_143_generated", "shape": null, "area": 0.64, "streetlevel": 1182.7000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1182.7000732421875, "distance_right": 3.9671280876034223e-07, "index_right": 150, "nodeid": "1393316.553906_5858975.725159", "id": "1393316.553906_5858975.725159", "name": "manhole_143_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393316.553906054003164, 5858975.725158606655896 ] } }, -{ "type": "Feature", "properties": { "_index": 150, "bedlevel": 1177.0999755859375, "branchid": "pipe_8_E123;pipe_8_E124", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_144_generated", "shape": null, "area": 0.64, "streetlevel": 1180.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1180.0999755859375, "distance_right": 6.7527730730815987e-07, "index_right": 151, "nodeid": "1393354.951424_5859007.684270", "id": "1393354.951424_5859007.684270", "name": "manhole_144_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393354.951424494385719, 5859007.684269540011883 ] } }, -{ "type": "Feature", "properties": { "_index": 151, "bedlevel": 1177.0999755859375, "branchid": "pipe_8_E124;pipe_8_E125", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_145_generated", "shape": null, "area": 0.64, "streetlevel": 1180.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1180.0999755859375, "distance_right": 4.7853676016253439e-07, "index_right": 152, "nodeid": "1393393.348943_5859039.643380", "id": "1393393.348943_5859039.643380", "name": "manhole_145_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393393.348942934535444, 5859039.643380474299192 ] } }, -{ "type": "Feature", "properties": { "_index": 152, "bedlevel": 1177.0999755859375, "branchid": "pipe_8_E125;pipe_8_E126", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_146_generated", "shape": null, "area": 0.64, "streetlevel": 1180.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1180.0999755859375, "distance_right": 5.54528936785255e-07, "index_right": 153, "nodeid": "1393431.746461_5859071.602491", "id": "1393431.746461_5859071.602491", "name": "manhole_146_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393431.746461374685168, 5859071.602491408586502 ] } }, -{ "type": "Feature", "properties": { "_index": 153, "bedlevel": 1199.5999755859375, "branchid": "pipe_8_E126;pipe_8_E127", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_147_generated", "shape": null, "area": 0.64, "streetlevel": 1202.5999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1202.5999755859375, "distance_right": 1.6846708957286895e-07, "index_right": 154, "nodeid": "1393472.672341_5859100.089054", "id": "1393472.672341_5859100.089054", "name": "manhole_147_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393472.672340910183266, 5859100.089053857140243 ] } }, -{ "type": "Feature", "properties": { "_index": 154, "bedlevel": 1199.5999755859375, "branchid": "pipe_8_E127;pipe_8_E128", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_148_generated", "shape": null, "area": 0.64, "streetlevel": 1202.5999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1202.5999755859375, "distance_right": 4.5059996646132258e-07, "index_right": 155, "nodeid": "1393507.678647_5859134.262683", "id": "1393507.678647_5859134.262683", "name": "manhole_148_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393507.678647378925234, 5859134.262682756409049 ] } }, -{ "type": "Feature", "properties": { "_index": 155, "bedlevel": 1199.5999755859375, "branchid": "pipe_8_E128;pipe_8_E129", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_149_generated", "shape": null, "area": 0.64, "streetlevel": 1202.5999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1202.5999755859375, "distance_right": 1.0640767988171364e-07, "index_right": 156, "nodeid": "1393492.637580_5859179.667013", "id": "1393492.637580_5859179.667013", "name": "manhole_149_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393492.637579936999828, 5859179.667013085447252 ] } }, -{ "type": "Feature", "properties": { "_index": 156, "bedlevel": 1229.300048828125, "branchid": "pipe_8_E129;pipe_8_E130", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_150_generated", "shape": null, "area": 0.64, "streetlevel": 1232.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1232.300048828125, "distance_right": 4.5958881840058565e-07, "index_right": 157, "nodeid": "1393472.727902_5859225.064155", "id": "1393472.727902_5859225.064155", "name": "manhole_150_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393472.727902054553851, 5859225.064155456610024 ] } }, -{ "type": "Feature", "properties": { "_index": 157, "bedlevel": 1229.300048828125, "branchid": "pipe_8_E130;pipe_8_E131", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_151_generated", "shape": null, "area": 0.64, "streetlevel": 1232.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1232.300048828125, "distance_right": 5.0290907014797333e-07, "index_right": 158, "nodeid": "1393467.563765_5859274.587596", "id": "1393467.563765_5859274.587596", "name": "manhole_151_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393467.563765458529815, 5859274.587596206925809 ] } }, -{ "type": "Feature", "properties": { "_index": 158, "bedlevel": 1229.300048828125, "branchid": "pipe_8_E131;pipe_8_E132", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_152_generated", "shape": null, "area": 0.64, "streetlevel": 1232.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1232.300048828125, "distance_right": 5.3579754438466911e-07, "index_right": 159, "nodeid": "1393473.514059_5859323.885010", "id": "1393473.514059_5859323.885010", "name": "manhole_152_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393473.51405850565061, 5859323.8850102070719 ] } }, -{ "type": "Feature", "properties": { "_index": 159, "bedlevel": 1229.300048828125, "branchid": "pipe_8_E132;pipe_8_E133", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_153_generated", "shape": null, "area": 0.64, "streetlevel": 1232.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1232.300048828125, "distance_right": 5.0577761653212759e-07, "index_right": 160, "nodeid": "1393507.773821_5859356.614803", "id": "1393507.773821_5859356.614803", "name": "manhole_153_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393507.773820924572647, 5859356.614802500233054 ] } }, -{ "type": "Feature", "properties": { "_index": 160, "bedlevel": 1211.800048828125, "branchid": "pipe_8_E133;pipe_8_E134", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_154_generated", "shape": null, "area": 0.64, "streetlevel": 1214.800048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1214.800048828125, "distance_right": 5.0605192731682803e-07, "index_right": 161, "nodeid": "1393555.824224_5859349.253152", "id": "1393555.824224_5859349.253152", "name": "manhole_154_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393555.824224345618859, 5859349.253152369521558 ] } }, -{ "type": "Feature", "properties": { "_index": 161, "bedlevel": 1211.800048828125, "branchid": "pipe_8_E134;pipe_8_E135", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_155_generated", "shape": null, "area": 0.64, "streetlevel": 1214.800048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1214.800048828125, "distance_right": 1.5717862002585569e-07, "index_right": 162, "nodeid": "1393591.003386_5859314.794960", "id": "1393591.003386_5859314.794960", "name": "manhole_155_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393591.00338595919311, 5859314.794959847815335 ] } }, -{ "type": "Feature", "properties": { "_index": 162, "bedlevel": 1188.0999755859375, "branchid": "pipe_8_E135;pipe_8_E136", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_156_generated", "shape": null, "area": 0.64, "streetlevel": 1191.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1191.0999755859375, "distance_right": 6.3842489402977489e-07, "index_right": 163, "nodeid": "1393633.153640_5859288.066565", "id": "1393633.153640_5859288.066565", "name": "manhole_156_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393633.153639519121498, 5859288.066565420478582 ] } }, -{ "type": "Feature", "properties": { "_index": 163, "bedlevel": 1188.0999755859375, "branchid": "pipe_8_E136;pipe_8_E137", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_157_generated", "shape": null, "area": 0.64, "streetlevel": 1191.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1191.0999755859375, "distance_right": 3.9680250819159843e-07, "index_right": 164, "nodeid": "1393673.123904_5859258.097713", "id": "1393673.123904_5859258.097713", "name": "manhole_157_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393673.123904188396409, 5859258.097712650895119 ] } }, -{ "type": "Feature", "properties": { "_index": 164, "bedlevel": 1141.300048828125, "branchid": "pipe_8_E137;pipe_8_E138", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_158_generated", "shape": null, "area": 0.64, "streetlevel": 1144.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1144.300048828125, "distance_right": 4.3319722731807235e-07, "index_right": 165, "nodeid": "1393720.523228_5859244.838273", "id": "1393720.523228_5859244.838273", "name": "manhole_158_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393720.523227575467899, 5859244.838272913359106 ] } }, -{ "type": "Feature", "properties": { "_index": 165, "bedlevel": 1141.300048828125, "branchid": "pipe_8_E138;pipe_8_E139", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_159_generated", "shape": null, "area": 0.64, "streetlevel": 1144.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1144.300048828125, "distance_right": 5.3625830630249993e-07, "index_right": 166, "nodeid": "1393765.710015_5859224.569285", "id": "1393765.710015_5859224.569285", "name": "manhole_159_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393765.710014625452459, 5859224.569284616038203 ] } }, -{ "type": "Feature", "properties": { "_index": 166, "bedlevel": 1141.300048828125, "branchid": "pipe_8_E139;pipe_8_E140", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_160_generated", "shape": null, "area": 0.64, "streetlevel": 1144.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1144.300048828125, "distance_right": 2.3237956298648694e-07, "index_right": 167, "nodeid": "1393806.409211_5859195.609256", "id": "1393806.409211_5859195.609256", "name": "manhole_160_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393806.409210936399177, 5859195.609256223775446 ] } }, -{ "type": "Feature", "properties": { "_index": 167, "bedlevel": 1109.5, "branchid": "pipe_8_E140", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_161_generated", "shape": null, "area": 0.64, "streetlevel": 1112.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1112.5, "distance_right": 5.8166784782944824e-07, "index_right": 168, "nodeid": "1393846.866743_5859166.301538", "id": "1393846.866743_5859166.301538", "name": "manhole_161_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393846.866742686368525, 5859166.301538489758968 ] } }, -{ "type": "Feature", "properties": { "_index": 168, "bedlevel": 965.29998779296875, "branchid": "pipe_9_E1045", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_162_generated", "shape": null, "area": 0.64, "streetlevel": 968.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 968.29998779296875, "distance_right": 6.2550722664998962e-07, "index_right": 169, "nodeid": "1388521.257593_5855362.027613", "id": "1388521.257593_5855362.027613", "name": "manhole_162_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388521.257592596346512, 5855362.027613477781415 ] } }, -{ "type": "Feature", "properties": { "_index": 168, "bedlevel": 965.29998779296875, "branchid": "pipe_9_E1045;pipe_9_E1046", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_163_generated", "shape": null, "area": 0.64, "streetlevel": 968.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 968.29998779296875, "distance_right": 2.491232398801703e-07, "index_right": 170, "nodeid": "1388472.030307_5855370.543776", "id": "1388472.030307_5855370.543776", "name": "manhole_163_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388472.030306826578453, 5855370.543775821104646 ] } }, -{ "type": "Feature", "properties": { "_index": 169, "bedlevel": 965.29998779296875, "branchid": "pipe_9_E1046;pipe_9_E1047", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_164_generated", "shape": null, "area": 0.64, "streetlevel": 968.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 968.29998779296875, "distance_right": 3.4109458847801294e-07, "index_right": 171, "nodeid": "1388439.000347_5855407.802593", "id": "1388439.000347_5855407.802593", "name": "manhole_164_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388439.000347282737494, 5855407.802592809312046 ] } }, -{ "type": "Feature", "properties": { "_index": 170, "bedlevel": 961.5, "branchid": "pipe_9_E1047;pipe_9_E1048", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_165_generated", "shape": null, "area": 0.64, "streetlevel": 964.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 964.5, "distance_right": 5.0422802117576567e-07, "index_right": 172, "nodeid": "1388400.196092_5855436.014135", "id": "1388400.196092_5855436.014135", "name": "manhole_165_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388400.196091859601438, 5855436.014134516008198 ] } }, -{ "type": "Feature", "properties": { "_index": 171, "bedlevel": 961.5, "branchid": "pipe_9_E1048;pipe_9_E1049", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_166_generated", "shape": null, "area": 0.64, "streetlevel": 964.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 964.5, "distance_right": 3.5808361406298709e-07, "index_right": 173, "nodeid": "1388351.338236_5855446.634319", "id": "1388351.338236_5855446.634319", "name": "manhole_166_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388351.33823574683629, 5855446.634319253265858 ] } }, -{ "type": "Feature", "properties": { "_index": 172, "bedlevel": 978.9000244140625, "branchid": "pipe_9_E1049;pipe_9_E1050", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_167_generated", "shape": null, "area": 0.64, "streetlevel": 981.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 981.9000244140625, "distance_right": 1.5594874151965919e-07, "index_right": 174, "nodeid": "1388301.961882_5855453.847478", "id": "1388301.961882_5855453.847478", "name": "manhole_167_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388301.961881892289966, 5855453.847477887757123 ] } }, -{ "type": "Feature", "properties": { "_index": 173, "bedlevel": 978.9000244140625, "branchid": "pipe_9_E1050;pipe_9_E1051", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_168_generated", "shape": null, "area": 0.64, "streetlevel": 981.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 981.9000244140625, "distance_right": 5.2900597904754769e-07, "index_right": 175, "nodeid": "1388252.297577_5855451.260453", "id": "1388252.297577_5855451.260453", "name": "manhole_168_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388252.297577269142494, 5855451.260453455150127 ] } }, -{ "type": "Feature", "properties": { "_index": 174, "bedlevel": 970.70001220703125, "branchid": "pipe_9_E1051;pipe_9_E1052", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_169_generated", "shape": null, "area": 0.64, "streetlevel": 973.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 973.70001220703125, "distance_right": 4.3128380993449448e-07, "index_right": 176, "nodeid": "1388202.479660_5855455.508815", "id": "1388202.479660_5855455.508815", "name": "manhole_169_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388202.479659734526649, 5855455.508814659900963 ] } }, -{ "type": "Feature", "properties": { "_index": 175, "bedlevel": 958.70001220703125, "branchid": "pipe_9_E1052;pipe_9_E1053", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_170_generated", "shape": null, "area": 0.64, "streetlevel": 961.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 961.70001220703125, "distance_right": 6.5691209318399445e-07, "index_right": 177, "nodeid": "1388152.683455_5855460.015516", "id": "1388152.683455_5855460.015516", "name": "manhole_170_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388152.683455461403355, 5855460.015516467392445 ] } }, -{ "type": "Feature", "properties": { "_index": 176, "bedlevel": 958.70001220703125, "branchid": "pipe_9_E1053;pipe_9_E1054", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_171_generated", "shape": null, "area": 0.64, "streetlevel": 961.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 961.70001220703125, "distance_right": 2.006546320325504e-07, "index_right": 178, "nodeid": "1388104.622612_5855473.253734", "id": "1388104.622612_5855473.253734", "name": "manhole_171_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388104.622611842118204, 5855473.253733876161277 ] } }, -{ "type": "Feature", "properties": { "_index": 177, "bedlevel": 942.79998779296875, "branchid": "pipe_9_E1054;pipe_9_E1055", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_172_generated", "shape": null, "area": 0.64, "streetlevel": 945.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 945.79998779296875, "distance_right": 5.4215854007679352e-07, "index_right": 179, "nodeid": "1388057.005634_5855488.445189", "id": "1388057.005634_5855488.445189", "name": "manhole_172_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388057.00563437351957, 5855488.445189393125474 ] } }, -{ "type": "Feature", "properties": { "_index": 178, "bedlevel": 942.79998779296875, "branchid": "pipe_9_E1055;pipe_9_E1056", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_173_generated", "shape": null, "area": 0.64, "streetlevel": 945.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 945.79998779296875, "distance_right": 6.3206294299772168e-07, "index_right": 180, "nodeid": "1388011.292357_5855508.700276", "id": "1388011.292357_5855508.700276", "name": "manhole_173_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388011.292356542311609, 5855508.700276436284184 ] } }, -{ "type": "Feature", "properties": { "_index": 179, "bedlevel": 942.79998779296875, "branchid": "pipe_9_E1056;pipe_9_E1057", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_174_generated", "shape": null, "area": 0.64, "streetlevel": 945.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 945.79998779296875, "distance_right": 5.3811609627278667e-07, "index_right": 181, "nodeid": "1387969.221703_5855535.246165", "id": "1387969.221703_5855535.246165", "name": "manhole_174_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387969.221702651120722, 5855535.246164590120316 ] } }, -{ "type": "Feature", "properties": { "_index": 180, "bedlevel": 927.79998779296875, "branchid": "pipe_9_E1057;pipe_9_E1058", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_175_generated", "shape": null, "area": 0.64, "streetlevel": 930.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 930.79998779296875, "distance_right": 3.5287172046738913e-07, "index_right": 182, "nodeid": "1387935.863196_5855572.491062", "id": "1387935.863196_5855572.491062", "name": "manhole_175_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387935.863196024205536, 5855572.491061648353934 ] } }, -{ "type": "Feature", "properties": { "_index": 181, "bedlevel": 954.10003662109375, "branchid": "pipe_9_E1058;pipe_9_E1059", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_176_generated", "shape": null, "area": 0.64, "streetlevel": 957.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 957.10003662109375, "distance_right": 3.4948996437128579e-07, "index_right": 183, "nodeid": "1387904.610232_5855611.432585", "id": "1387904.610232_5855611.432585", "name": "manhole_176_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387904.610231971368194, 5855611.432584651745856 ] } }, -{ "type": "Feature", "properties": { "_index": 182, "bedlevel": 944.4000244140625, "branchid": "pipe_9_E1059;pipe_9_E1060", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_177_generated", "shape": null, "area": 0.64, "streetlevel": 947.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 947.4000244140625, "distance_right": 3.5311037385386945e-07, "index_right": 184, "nodeid": "1387869.335365_5855646.852918", "id": "1387869.335365_5855646.852918", "name": "manhole_177_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387869.335365027422085, 5855646.852918352000415 ] } }, -{ "type": "Feature", "properties": { "_index": 183, "bedlevel": 944.4000244140625, "branchid": "pipe_9_E1060;pipe_9_E1061", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_178_generated", "shape": null, "area": 0.64, "streetlevel": 947.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 947.4000244140625, "distance_right": 2.4558777189375542e-07, "index_right": 185, "nodeid": "1387831.783289_5855679.735664", "id": "1387831.783289_5855679.735664", "name": "manhole_178_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387831.783288773847744, 5855679.735664095729589 ] } }, -{ "type": "Feature", "properties": { "_index": 184, "bedlevel": 944.4000244140625, "branchid": "pipe_9_E1061;pipe_9_E1062", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_179_generated", "shape": null, "area": 0.64, "streetlevel": 947.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 947.4000244140625, "distance_right": 4.6498657917073899e-07, "index_right": 186, "nodeid": "1387791.509416_5855708.923280", "id": "1387791.509416_5855708.923280", "name": "manhole_179_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387791.509416193468496, 5855708.923279576934874 ] } }, -{ "type": "Feature", "properties": { "_index": 185, "bedlevel": 930.29998779296875, "branchid": "pipe_9_E1062;pipe_9_E1063", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_180_generated", "shape": null, "area": 0.64, "streetlevel": 933.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 933.29998779296875, "distance_right": 2.8252183007269098e-07, "index_right": 187, "nodeid": "1387742.459817_5855717.213658", "id": "1387742.459817_5855717.213658", "name": "manhole_180_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387742.459816947113723, 5855717.213657722808421 ] } }, -{ "type": "Feature", "properties": { "_index": 186, "bedlevel": 930.29998779296875, "branchid": "pipe_9_E1063;pipe_9_E1064", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_181_generated", "shape": null, "area": 0.64, "streetlevel": 933.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 933.29998779296875, "distance_right": 3.5363288221426471e-07, "index_right": 188, "nodeid": "1387692.500367_5855718.495404", "id": "1387692.500367_5855718.495404", "name": "manhole_181_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387692.500367184402421, 5855718.495403698645532 ] } }, -{ "type": "Feature", "properties": { "_index": 187, "bedlevel": 908.10003662109375, "branchid": "pipe_9_E1064;pipe_9_E1065", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_182_generated", "shape": null, "area": 0.64, "streetlevel": 911.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 911.10003662109375, "distance_right": 4.9034736079246513e-07, "index_right": 189, "nodeid": "1387642.500798_5855718.619679", "id": "1387642.500798_5855718.619679", "name": "manhole_182_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387642.500798417022452, 5855718.61967874225229 ] } }, -{ "type": "Feature", "properties": { "_index": 188, "bedlevel": 884.70001220703125, "branchid": "pipe_9_E1065;pipe_9_E1066", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_183_generated", "shape": null, "area": 0.64, "streetlevel": 887.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 887.70001220703125, "distance_right": 4.1118188309736872e-07, "index_right": 190, "nodeid": "1387592.501230_5855718.743954", "id": "1387592.501230_5855718.743954", "name": "manhole_183_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387592.501229649642482, 5855718.743953784927726 ] } }, -{ "type": "Feature", "properties": { "_index": 189, "bedlevel": 884.70001220703125, "branchid": "pipe_9_E1066;pipe_9_E1067", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_184_generated", "shape": null, "area": 0.64, "streetlevel": 887.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 887.70001220703125, "distance_right": 2.0872277033035481e-07, "index_right": 191, "nodeid": "1387542.501661_5855718.868229", "id": "1387542.501661_5855718.868229", "name": "manhole_184_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387542.501660882262513, 5855718.868228827603161 ] } }, -{ "type": "Feature", "properties": { "_index": 190, "bedlevel": 899.9000244140625, "branchid": "pipe_9_E1067;pipe_9_E1068", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_185_generated", "shape": null, "area": 0.64, "streetlevel": 902.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 902.9000244140625, "distance_right": 5.0275511809117188e-07, "index_right": 192, "nodeid": "1387492.651410_5855720.815255", "id": "1387492.651410_5855720.815255", "name": "manhole_185_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387492.651409652316943, 5855720.815255363471806 ] } }, -{ "type": "Feature", "properties": { "_index": 191, "bedlevel": 899.9000244140625, "branchid": "pipe_9_E1068;pipe_9_E1069", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_186_generated", "shape": null, "area": 0.64, "streetlevel": 902.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 902.9000244140625, "distance_right": 4.0143784259993902e-07, "index_right": 193, "nodeid": "1387448.867237_5855742.752517", "id": "1387448.867237_5855742.752517", "name": "manhole_186_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387448.867236748570576, 5855742.752516686916351 ] } }, -{ "type": "Feature", "properties": { "_index": 192, "bedlevel": 883.20001220703125, "branchid": "pipe_9_E1069;pipe_9_E1070", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_187_generated", "shape": null, "area": 0.64, "streetlevel": 886.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 886.20001220703125, "distance_right": 5.0383308575468889e-07, "index_right": 194, "nodeid": "1387402.432745_5855761.091834", "id": "1387402.432745_5855761.091834", "name": "manhole_187_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387402.432745414320379, 5855761.091833713464439 ] } }, -{ "type": "Feature", "properties": { "_index": 193, "bedlevel": 883.20001220703125, "branchid": "pipe_9_E1070;pipe_9_E1071", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_188_generated", "shape": null, "area": 0.64, "streetlevel": 886.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 886.20001220703125, "distance_right": 6.1468436428462281e-07, "index_right": 195, "nodeid": "1387355.687973_5855778.837216", "id": "1387355.687973_5855778.837216", "name": "manhole_188_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387355.687973388005048, 5855778.837216476909816 ] } }, -{ "type": "Feature", "properties": { "_index": 194, "bedlevel": 876.4000244140625, "branchid": "pipe_9_E1071;pipe_9_E1072", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_189_generated", "shape": null, "area": 0.64, "streetlevel": 879.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 879.4000244140625, "distance_right": 4.3414225157022518e-07, "index_right": 196, "nodeid": "1387308.943201_5855796.582599", "id": "1387308.943201_5855796.582599", "name": "manhole_189_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387308.943201361689717, 5855796.582599240355194 ] } }, -{ "type": "Feature", "properties": { "_index": 195, "bedlevel": 876.4000244140625, "branchid": "pipe_9_E1072;pipe_9_E1073", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_190_generated", "shape": null, "area": 0.64, "streetlevel": 879.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 879.4000244140625, "distance_right": 5.7963084690905175e-07, "index_right": 197, "nodeid": "1387262.861614_5855815.656713", "id": "1387262.861614_5855815.656713", "name": "manhole_190_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387262.861613623332232, 5855815.656713440082967 ] } }, -{ "type": "Feature", "properties": { "_index": 196, "bedlevel": 870.29998779296875, "branchid": "pipe_9_E1073;pipe_9_E1074", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_191_generated", "shape": null, "area": 0.64, "streetlevel": 873.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 873.29998779296875, "distance_right": 3.5155299271124064e-07, "index_right": 198, "nodeid": "1387224.059019_5855846.996292", "id": "1387224.059019_5855846.996292", "name": "manhole_191_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387224.059019178850576, 5855846.996291697025299 ] } }, -{ "type": "Feature", "properties": { "_index": 197, "bedlevel": 935.9000244140625, "branchid": "pipe_9_E1074;pipe_9_E1075", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_192_generated", "shape": null, "area": 0.64, "streetlevel": 938.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 938.9000244140625, "distance_right": 2.5239529085654171e-07, "index_right": 199, "nodeid": "1387180.719125_5855870.194652", "id": "1387180.719125_5855870.194652", "name": "manhole_192_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387180.719124856637791, 5855870.194651792757213 ] } }, -{ "type": "Feature", "properties": { "_index": 198, "bedlevel": 929.79998779296875, "branchid": "pipe_9_E1075;pipe_9_E1076", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_193_generated", "shape": null, "area": 0.64, "streetlevel": 932.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 932.79998779296875, "distance_right": 6.3377412160898568e-07, "index_right": 200, "nodeid": "1387131.003996_5855874.064550", "id": "1387131.003996_5855874.064550", "name": "manhole_193_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387131.003996425773948, 5855874.064550469629467 ] } }, -{ "type": "Feature", "properties": { "_index": 199, "bedlevel": 929.79998779296875, "branchid": "pipe_9_E1076;pipe_9_E1077", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_194_generated", "shape": null, "area": 0.64, "streetlevel": 932.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 932.79998779296875, "distance_right": 3.1656748918229132e-07, "index_right": 201, "nodeid": "1387081.098878_5855871.158614", "id": "1387081.098878_5855871.158614", "name": "manhole_194_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387081.098878284916282, 5855871.158613862469792 ] } }, -{ "type": "Feature", "properties": { "_index": 200, "bedlevel": 913.79998779296875, "branchid": "pipe_9_E1077;pipe_9_E1078", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_195_generated", "shape": null, "area": 0.64, "streetlevel": 916.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 916.79998779296875, "distance_right": 2.831909844189002e-07, "index_right": 202, "nodeid": "1387031.198060_5855868.015261", "id": "1387031.198060_5855868.015261", "name": "manhole_195_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387031.198060098802671, 5855868.015261265449226 ] } }, -{ "type": "Feature", "properties": { "_index": 201, "bedlevel": 913.79998779296875, "branchid": "pipe_9_E1078;pipe_9_E1079", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_196_generated", "shape": null, "area": 0.64, "streetlevel": 916.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 916.79998779296875, "distance_right": 3.4381447680653237e-07, "index_right": 203, "nodeid": "1386981.297242_5855864.871909", "id": "1386981.297242_5855864.871909", "name": "manhole_196_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386981.297241912456229, 5855864.871908667497337 ] } }, -{ "type": "Feature", "properties": { "_index": 202, "bedlevel": 888.79998779296875, "branchid": "pipe_9_E1079;pipe_9_E1080", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_197_generated", "shape": null, "area": 0.64, "streetlevel": 891.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 891.79998779296875, "distance_right": 4.0001585263297416e-07, "index_right": 204, "nodeid": "1386931.471473_5855860.718020", "id": "1386931.471473_5855860.718020", "name": "manhole_197_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386931.47147326474078, 5855860.718019699677825 ] } }, -{ "type": "Feature", "properties": { "_index": 203, "bedlevel": 888.79998779296875, "branchid": "pipe_9_E1080;pipe_9_E1081", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_198_generated", "shape": null, "area": 0.64, "streetlevel": 891.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 891.79998779296875, "distance_right": 2.4718676670200831e-07, "index_right": 205, "nodeid": "1386881.600664_5855857.577048", "id": "1386881.600664_5855857.577048", "name": "manhole_198_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386881.600663758814335, 5855857.577047945931554 ] } }, -{ "type": "Feature", "properties": { "_index": 204, "bedlevel": 854.10003662109375, "branchid": "pipe_9_E1081;pipe_9_E1082", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_199_generated", "shape": null, "area": 0.64, "streetlevel": 857.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 857.10003662109375, "distance_right": 2.9128081306257761e-07, "index_right": 206, "nodeid": "1386832.545594_5855864.100992", "id": "1386832.545594_5855864.100992", "name": "manhole_199_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386832.545593914575875, 5855864.100992278195918 ] } }, -{ "type": "Feature", "properties": { "_index": 205, "bedlevel": 854.10003662109375, "branchid": "pipe_9_E1082;pipe_9_E1083", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_200_generated", "shape": null, "area": 0.64, "streetlevel": 857.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 857.10003662109375, "distance_right": 5.9499673960858676e-07, "index_right": 207, "nodeid": "1386787.067649_5855884.403254", "id": "1386787.067649_5855884.403254", "name": "manhole_200_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386787.06764860637486, 5855884.403254445642233 ] } }, -{ "type": "Feature", "properties": { "_index": 206, "bedlevel": 818.29998779296875, "branchid": "pipe_9_E1083;pipe_9_E1084", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_201_generated", "shape": null, "area": 0.64, "streetlevel": 821.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 821.29998779296875, "distance_right": 4.2555588649120384e-07, "index_right": 208, "nodeid": "1386748.278359_5855915.544586", "id": "1386748.278359_5855915.544586", "name": "manhole_201_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386748.278358669718727, 5855915.544586268253624 ] } }, -{ "type": "Feature", "properties": { "_index": 207, "bedlevel": 818.29998779296875, "branchid": "pipe_9_E1084;pipe_9_E1085", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_202_generated", "shape": null, "area": 0.64, "streetlevel": 821.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 821.29998779296875, "distance_right": 2.4685857327161614e-07, "index_right": 209, "nodeid": "1386721.155420_5855957.124279", "id": "1386721.155420_5855957.124279", "name": "manhole_202_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386721.155419877264649, 5855957.124278785660863 ] } }, -{ "type": "Feature", "properties": { "_index": 208, "bedlevel": 863.0, "branchid": "pipe_9_E1085;pipe_9_E1086", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_203_generated", "shape": null, "area": 0.64, "streetlevel": 866.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 866.0, "distance_right": 2.8019898345367699e-07, "index_right": 210, "nodeid": "1386707.750366_5856004.850833", "id": "1386707.750366_5856004.850833", "name": "manhole_203_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386707.750365849817172, 5856004.850832763127983 ] } }, -{ "type": "Feature", "properties": { "_index": 209, "bedlevel": 863.0, "branchid": "pipe_9_E1086;pipe_9_E1087", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_204_generated", "shape": null, "area": 0.64, "streetlevel": 866.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 866.0, "distance_right": 1.6853915390145023e-07, "index_right": 211, "nodeid": "1386699.832476_5856054.133604", "id": "1386699.832476_5856054.133604", "name": "manhole_204_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386699.832475832896307, 5856054.133603978902102 ] } }, -{ "type": "Feature", "properties": { "_index": 210, "bedlevel": 863.0, "branchid": "pipe_9_E1087;pipe_9_E1088", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_205_generated", "shape": null, "area": 0.64, "streetlevel": 866.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 866.0, "distance_right": 2.7790305142427269e-07, "index_right": 212, "nodeid": "1386697.095561_5856103.986880", "id": "1386697.095561_5856103.986880", "name": "manhole_205_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386697.095561265014112, 5856103.986880083568394 ] } }, -{ "type": "Feature", "properties": { "_index": 211, "bedlevel": 881.79998779296875, "branchid": "pipe_9_E1088;pipe_9_E1089", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_206_generated", "shape": null, "area": 0.64, "streetlevel": 884.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 884.79998779296875, "distance_right": 9.6871259171155416e-08, "index_right": 213, "nodeid": "1386699.401159_5856153.933417", "id": "1386699.401159_5856153.933417", "name": "manhole_206_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386699.401158998254687, 5856153.933416903018951 ] } }, -{ "type": "Feature", "properties": { "_index": 212, "bedlevel": 881.79998779296875, "branchid": "pipe_9_E1089;pipe_9_E1090", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_207_generated", "shape": null, "area": 0.64, "streetlevel": 884.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 884.79998779296875, "distance_right": 3.3371584559582528e-07, "index_right": 214, "nodeid": "1386715.699191_5856201.197658", "id": "1386715.699191_5856201.197658", "name": "manhole_207_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386715.699191288091242, 5856201.197657831013203 ] } }, -{ "type": "Feature", "properties": { "_index": 213, "bedlevel": 881.79998779296875, "branchid": "pipe_9_E1090;pipe_9_E1091", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_208_generated", "shape": null, "area": 0.64, "streetlevel": 884.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 884.79998779296875, "distance_right": 3.0366052469250063e-07, "index_right": 215, "nodeid": "1386741.121204_5856244.100117", "id": "1386741.121204_5856244.100117", "name": "manhole_208_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386741.121203816728666, 5856244.100116757676005 ] } }, -{ "type": "Feature", "properties": { "_index": 214, "bedlevel": 912.9000244140625, "branchid": "pipe_9_E1091;pipe_9_E1092", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_209_generated", "shape": null, "area": 0.64, "streetlevel": 915.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 915.9000244140625, "distance_right": 5.1144535471282637e-07, "index_right": 216, "nodeid": "1386774.051379_5856281.577651", "id": "1386774.051379_5856281.577651", "name": "manhole_209_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386774.051378605188802, 5856281.577651324681938 ] } }, -{ "type": "Feature", "properties": { "_index": 215, "bedlevel": 912.9000244140625, "branchid": "pipe_9_E1092;pipe_9_E1093", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_210_generated", "shape": null, "area": 0.64, "streetlevel": 915.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 915.9000244140625, "distance_right": 3.3487951427448095e-07, "index_right": 217, "nodeid": "1386811.583792_5856314.587093", "id": "1386811.583792_5856314.587093", "name": "manhole_210_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386811.583791718119755, 5856314.587093180976808 ] } }, -{ "type": "Feature", "properties": { "_index": 216, "bedlevel": 912.9000244140625, "branchid": "pipe_9_E1093;pipe_9_E1094", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_211_generated", "shape": null, "area": 0.64, "streetlevel": 915.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 915.9000244140625, "distance_right": 5.1367843572055332e-07, "index_right": 218, "nodeid": "1386839.378956_5856356.087350", "id": "1386839.378956_5856356.087350", "name": "manhole_211_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386839.378956499742344, 5856356.087350118905306 ] } }, -{ "type": "Feature", "properties": { "_index": 217, "bedlevel": 906.9000244140625, "branchid": "pipe_9_E1094;pipe_9_E1095", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_212_generated", "shape": null, "area": 0.64, "streetlevel": 909.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 909.9000244140625, "distance_right": 5.187509063779675e-07, "index_right": 219, "nodeid": "1386855.653892_5856403.364182", "id": "1386855.653892_5856403.364182", "name": "manhole_212_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386855.653891535941511, 5856403.364181768149137 ] } }, -{ "type": "Feature", "properties": { "_index": 218, "bedlevel": 906.9000244140625, "branchid": "pipe_9_E1095;pipe_9_E1096", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_213_generated", "shape": null, "area": 0.64, "streetlevel": 909.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 909.9000244140625, "distance_right": 8.9501807475047818e-08, "index_right": 220, "nodeid": "1386875.714554_5856449.116946", "id": "1386875.714554_5856449.116946", "name": "manhole_213_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386875.714553950354457, 5856449.116945925168693 ] } }, -{ "type": "Feature", "properties": { "_index": 219, "bedlevel": 906.9000244140625, "branchid": "pipe_9_E1096;pipe_9_E1097", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_214_generated", "shape": null, "area": 0.64, "streetlevel": 909.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 909.9000244140625, "distance_right": 3.7253492332524094e-07, "index_right": 221, "nodeid": "1386912.179653_5856482.939191", "id": "1386912.179653_5856482.939191", "name": "manhole_214_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386912.179653002182022, 5856482.939191372133791 ] } }, -{ "type": "Feature", "properties": { "_index": 220, "bedlevel": 906.9000244140625, "branchid": "pipe_9_E1097;pipe_9_E1098", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_215_generated", "shape": null, "area": 0.64, "streetlevel": 909.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 909.9000244140625, "distance_right": 3.9641753867010345e-07, "index_right": 222, "nodeid": "1386944.191176_5856520.270726", "id": "1386944.191176_5856520.270726", "name": "manhole_215_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386944.191176384687424, 5856520.270725904032588 ] } }, -{ "type": "Feature", "properties": { "_index": 221, "bedlevel": 908.79998779296875, "branchid": "pipe_9_E1098;pipe_9_E1099", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_216_generated", "shape": null, "area": 0.64, "streetlevel": 911.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 911.79998779296875, "distance_right": 3.0347837754102234e-07, "index_right": 223, "nodeid": "1386964.188513_5856566.025076", "id": "1386964.188513_5856566.025076", "name": "manhole_216_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386964.188513180473819, 5856566.025075756013393 ] } }, -{ "type": "Feature", "properties": { "_index": 222, "bedlevel": 908.79998779296875, "branchid": "pipe_9_E1099;pipe_9_E1100", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_217_generated", "shape": null, "area": 0.64, "streetlevel": 911.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 911.79998779296875, "distance_right": 5.6084818431140973e-07, "index_right": 224, "nodeid": "1386998.825215_5856599.261942", "id": "1386998.825215_5856599.261942", "name": "manhole_217_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386998.825215350603685, 5856599.261941562406719 ] } }, -{ "type": "Feature", "properties": { "_index": 223, "bedlevel": 929.0, "branchid": "pipe_9_E1100;pipe_9_E1101", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_218_generated", "shape": null, "area": 0.64, "streetlevel": 932.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 932.0, "distance_right": 3.735616577513179e-07, "index_right": 225, "nodeid": "1387044.828527_5856618.849378", "id": "1387044.828527_5856618.849378", "name": "manhole_218_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387044.828526843106374, 5856618.849377661012113 ] } }, -{ "type": "Feature", "properties": { "_index": 224, "bedlevel": 929.0, "branchid": "pipe_9_E1101;pipe_9_E1102", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_219_generated", "shape": null, "area": 0.64, "streetlevel": 932.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 932.0, "distance_right": 4.1213424511758264e-07, "index_right": 226, "nodeid": "1387090.831838_5856638.436814", "id": "1387090.831838_5856638.436814", "name": "manhole_219_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387090.831838335609064, 5856638.43681376054883 ] } }, -{ "type": "Feature", "properties": { "_index": 225, "bedlevel": 946.9000244140625, "branchid": "pipe_9_E1102;pipe_9_E1103", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_220_generated", "shape": null, "area": 0.64, "streetlevel": 949.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 949.9000244140625, "distance_right": 2.2222059697487855e-07, "index_right": 227, "nodeid": "1387136.835150_5856658.024250", "id": "1387136.835150_5856658.024250", "name": "manhole_220_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387136.835149827878922, 5856658.024249859154224 ] } }, -{ "type": "Feature", "properties": { "_index": 226, "bedlevel": 921.4000244140625, "branchid": "pipe_9_E1103;pipe_9_E1104", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_221_generated", "shape": null, "area": 0.64, "streetlevel": 924.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 924.4000244140625, "distance_right": 5.4986578490835315e-07, "index_right": 228, "nodeid": "1387178.671980_5856685.128790", "id": "1387178.671980_5856685.128790", "name": "manhole_221_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387178.671980312326923, 5856685.128790453076363 ] } }, -{ "type": "Feature", "properties": { "_index": 227, "bedlevel": 921.4000244140625, "branchid": "pipe_9_E1104;pipe_9_E1105", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_222_generated", "shape": null, "area": 0.64, "streetlevel": 924.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 924.4000244140625, "distance_right": 4.3358267338019524e-07, "index_right": 229, "nodeid": "1387217.700536_5856716.320353", "id": "1387217.700536_5856716.320353", "name": "manhole_222_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387217.700535611249506, 5856716.320352808572352 ] } }, -{ "type": "Feature", "properties": { "_index": 228, "bedlevel": 937.0, "branchid": "pipe_9_E1105;pipe_9_E1106", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_223_generated", "shape": null, "area": 0.64, "streetlevel": 940.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 940.0, "distance_right": 6.2336673131863649e-07, "index_right": 230, "nodeid": "1387252.016687_5856752.649443", "id": "1387252.016687_5856752.649443", "name": "manhole_223_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387252.016686553368345, 5856752.649443434551358 ] } }, -{ "type": "Feature", "properties": { "_index": 229, "bedlevel": 937.0, "branchid": "pipe_9_E1106;pipe_9_E1107", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_224_generated", "shape": null, "area": 0.64, "streetlevel": 940.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 940.0, "distance_right": 6.6799533663431727e-07, "index_right": 231, "nodeid": "1387284.798919_5856790.190160", "id": "1387284.798919_5856790.190160", "name": "manhole_224_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387284.798919493798167, 5856790.190159549936652 ] } }, -{ "type": "Feature", "properties": { "_index": 230, "bedlevel": 891.29998779296875, "branchid": "pipe_9_E1107;pipe_9_E1108", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_225_generated", "shape": null, "area": 0.64, "streetlevel": 894.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 894.29998779296875, "distance_right": 5.7531995052493763e-07, "index_right": 232, "nodeid": "1387273.050185_5856831.931571", "id": "1387273.050185_5856831.931571", "name": "manhole_225_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387273.050185391213745, 5856831.931571422144771 ] } }, -{ "type": "Feature", "properties": { "_index": 231, "bedlevel": 888.5, "branchid": "pipe_9_E1108;pipe_9_E1109", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_226_generated", "shape": null, "area": 0.64, "streetlevel": 891.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 891.5, "distance_right": 4.1743411269132557e-07, "index_right": 233, "nodeid": "1387226.106990_5856849.145193", "id": "1387226.106990_5856849.145193", "name": "manhole_226_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387226.106990416301414, 5856849.145192969590425 ] } }, -{ "type": "Feature", "properties": { "_index": 232, "bedlevel": 888.5, "branchid": "pipe_9_E1109;pipe_9_E1110", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_227_generated", "shape": null, "area": 0.64, "streetlevel": 891.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 891.5, "distance_right": 6.552938118098987e-07, "index_right": 234, "nodeid": "1387179.163795_5856866.358815", "id": "1387179.163795_5856866.358815", "name": "manhole_227_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387179.163795441389084, 5856866.358814516104758 ] } }, -{ "type": "Feature", "properties": { "_index": 233, "bedlevel": 878.0, "branchid": "pipe_9_E1110;pipe_9_E1111", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_228_generated", "shape": null, "area": 0.64, "streetlevel": 881.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 881.0, "distance_right": 4.7110155232047406e-07, "index_right": 235, "nodeid": "1387132.220600_5856883.572436", "id": "1387132.220600_5856883.572436", "name": "manhole_228_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387132.220600466709584, 5856883.572436063550413 ] } }, -{ "type": "Feature", "properties": { "_index": 234, "bedlevel": 878.0, "branchid": "pipe_9_E1111;pipe_9_E1112", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_229_generated", "shape": null, "area": 0.64, "streetlevel": 881.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 881.0, "distance_right": 4.5292742057497235e-07, "index_right": 236, "nodeid": "1387091.513160_5856911.129931", "id": "1387091.513160_5856911.129931", "name": "manhole_229_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387091.513159692520276, 5856911.129930667579174 ] } }, -{ "type": "Feature", "properties": { "_index": 235, "bedlevel": 878.0, "branchid": "pipe_9_E1112;pipe_9_E1113", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_230_generated", "shape": null, "area": 0.64, "streetlevel": 881.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 881.0, "distance_right": 4.9429945647716522e-07, "index_right": 237, "nodeid": "1387071.007118_5856956.155595", "id": "1387071.007118_5856956.155595", "name": "manhole_230_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387071.007118243258446, 5856956.15559543017298 ] } }, -{ "type": "Feature", "properties": { "_index": 236, "bedlevel": 878.0, "branchid": "pipe_9_E1113;pipe_9_E1114", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_231_generated", "shape": null, "area": 0.64, "streetlevel": 881.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 881.0, "distance_right": 1.6586957023213196e-07, "index_right": 238, "nodeid": "1387043.749112_5856996.689189", "id": "1387043.749112_5856996.689189", "name": "manhole_231_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387043.749112035380676, 5856996.689189162105322 ] } }, -{ "type": "Feature", "properties": { "_index": 237, "bedlevel": 853.5, "branchid": "pipe_9_E1114;pipe_9_E1115", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_232_generated", "shape": null, "area": 0.64, "streetlevel": 856.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 856.5, "distance_right": 3.8972706268118116e-07, "index_right": 239, "nodeid": "1387004.639444_5857027.840532", "id": "1387004.639444_5857027.840532", "name": "manhole_232_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387004.639443967491388, 5857027.840532388538122 ] } }, -{ "type": "Feature", "properties": { "_index": 238, "bedlevel": 853.5, "branchid": "pipe_9_E1115;pipe_9_E1116", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_233_generated", "shape": null, "area": 0.64, "streetlevel": 856.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 856.5, "distance_right": 3.9655125764235331e-07, "index_right": 240, "nodeid": "1386965.529776_5857058.991876", "id": "1386965.529776_5857058.991876", "name": "manhole_233_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386965.529775899834931, 5857058.991875615902245 ] } }, -{ "type": "Feature", "properties": { "_index": 239, "bedlevel": 853.5, "branchid": "pipe_9_E1116;pipe_9_E1117", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_234_generated", "shape": null, "area": 0.64, "streetlevel": 856.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 856.5, "distance_right": 2.748546764829618e-07, "index_right": 241, "nodeid": "1386926.702535_5857090.440240", "id": "1386926.702535_5857090.440240", "name": "manhole_234_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386926.702535050921142, 5857090.440239730291069 ] } }, -{ "type": "Feature", "properties": { "_index": 240, "bedlevel": 853.5, "branchid": "pipe_9_E1117;pipe_9_E1118", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_235_generated", "shape": null, "area": 0.64, "streetlevel": 856.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 856.5, "distance_right": 1.2768484294624656e-07, "index_right": 242, "nodeid": "1386899.700980_5857131.871505", "id": "1386899.700980_5857131.871505", "name": "manhole_235_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386899.700979894958436, 5857131.871505072340369 ] } }, -{ "type": "Feature", "properties": { "_index": 241, "bedlevel": 853.5, "branchid": "pipe_9_E1118;pipe_9_E1119", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_236_generated", "shape": null, "area": 0.64, "streetlevel": 856.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 856.5, "distance_right": 1.5272838380511377e-07, "index_right": 243, "nodeid": "1386903.626394_5857181.005935", "id": "1386903.626394_5857181.005935", "name": "manhole_236_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386903.6263940166682, 5857181.005935152061284 ] } }, -{ "type": "Feature", "properties": { "_index": 242, "bedlevel": 864.29998779296875, "branchid": "pipe_9_E1119;pipe_9_E1120", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_237_generated", "shape": null, "area": 0.64, "streetlevel": 867.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 867.29998779296875, "distance_right": 3.2024778037221965e-07, "index_right": 244, "nodeid": "1386920.841402_5857227.857345", "id": "1386920.841402_5857227.857345", "name": "manhole_237_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386920.841401966754347, 5857227.85734468139708 ] } }, -{ "type": "Feature", "properties": { "_index": 243, "bedlevel": 864.29998779296875, "branchid": "pipe_9_E1120;pipe_9_E1121", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_238_generated", "shape": null, "area": 0.64, "streetlevel": 867.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 867.29998779296875, "distance_right": 5.1321625639033407e-07, "index_right": 245, "nodeid": "1386940.647245_5857273.767048", "id": "1386940.647245_5857273.767048", "name": "manhole_238_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386940.647245415020734, 5857273.767048302106559 ] } }, -{ "type": "Feature", "properties": { "_index": 244, "bedlevel": 876.0, "branchid": "pipe_9_E1121;pipe_9_E1122", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_239_generated", "shape": null, "area": 0.64, "streetlevel": 879.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 879.0, "distance_right": 1.5727567798101456e-07, "index_right": 246, "nodeid": "1386960.453089_5857319.676752", "id": "1386960.453089_5857319.676752", "name": "manhole_239_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386960.453088863519952, 5857319.676751921884716 ] } }, -{ "type": "Feature", "properties": { "_index": 245, "bedlevel": 881.5, "branchid": "pipe_9_E1122;pipe_9_E1123", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_240_generated", "shape": null, "area": 0.64, "streetlevel": 884.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 884.5, "distance_right": 5.5344274981313694e-07, "index_right": 247, "nodeid": "1386980.258932_5857365.586456", "id": "1386980.258932_5857365.586456", "name": "manhole_240_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386980.258932311786339, 5857365.586455542594194 ] } }, -{ "type": "Feature", "properties": { "_index": 246, "bedlevel": 881.5, "branchid": "pipe_9_E1123;pipe_9_E1124", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_241_generated", "shape": null, "area": 0.64, "streetlevel": 884.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 884.5, "distance_right": 2.8943349532980884e-07, "index_right": 248, "nodeid": "1387000.064776_5857411.496159", "id": "1387000.064776_5857411.496159", "name": "manhole_241_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387000.064775760285556, 5857411.496159162372351 ] } }, -{ "type": "Feature", "properties": { "_index": 247, "bedlevel": 881.5, "branchid": "pipe_9_E1124;pipe_9_E1125", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_242_generated", "shape": null, "area": 0.64, "streetlevel": 884.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 884.5, "distance_right": 1.5183128884474304e-07, "index_right": 249, "nodeid": "1387007.528902_5857459.537025", "id": "1387007.528902_5857459.537025", "name": "manhole_242_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387007.528902114601806, 5857459.537025099620223 ] } }, -{ "type": "Feature", "properties": { "_index": 248, "bedlevel": 890.20001220703125, "branchid": "pipe_9_E1125;pipe_9_E1126", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_243_generated", "shape": null, "area": 0.64, "streetlevel": 893.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 893.20001220703125, "distance_right": 3.2273594401468987e-07, "index_right": 250, "nodeid": "1386963.216765_5857476.629049", "id": "1386963.216765_5857476.629049", "name": "manhole_243_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386963.21676475298591, 5857476.629049208015203 ] } }, -{ "type": "Feature", "properties": { "_index": 249, "bedlevel": 890.70001220703125, "branchid": "pipe_9_E1126;pipe_9_E1127", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_244_generated", "shape": null, "area": 0.64, "streetlevel": 893.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 893.70001220703125, "distance_right": 4.1073674898211013e-07, "index_right": 251, "nodeid": "1386913.783934_5857484.135434", "id": "1386913.783934_5857484.135434", "name": "manhole_244_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386913.783934087026864, 5857484.135433598421514 ] } }, -{ "type": "Feature", "properties": { "_index": 250, "bedlevel": 890.70001220703125, "branchid": "pipe_9_E1127;pipe_9_E1128", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_245_generated", "shape": null, "area": 0.64, "streetlevel": 893.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 893.70001220703125, "distance_right": 3.5443776076362833e-07, "index_right": 252, "nodeid": "1386870.539328_5857507.055612", "id": "1386870.539328_5857507.055612", "name": "manhole_245_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386870.539328352315351, 5857507.055611960589886 ] } }, -{ "type": "Feature", "properties": { "_index": 251, "bedlevel": 886.70001220703125, "branchid": "pipe_9_E1128;pipe_9_E1129", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_246_generated", "shape": null, "area": 0.64, "streetlevel": 889.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 889.70001220703125, "distance_right": 2.5526777072037769e-07, "index_right": 253, "nodeid": "1386832.820274_5857539.877027", "id": "1386832.820274_5857539.877027", "name": "manhole_246_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386832.820274166297168, 5857539.877026806585491 ] } }, -{ "type": "Feature", "properties": { "_index": 252, "bedlevel": 886.70001220703125, "branchid": "pipe_9_E1129;pipe_9_E1130", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_247_generated", "shape": null, "area": 0.64, "streetlevel": 889.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 889.70001220703125, "distance_right": 1.5366822481155396e-07, "index_right": 254, "nodeid": "1386795.101532_5857572.698800", "id": "1386795.101532_5857572.698800", "name": "manhole_247_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386795.101531907683238, 5857572.698800123296678 ] } }, -{ "type": "Feature", "properties": { "_index": 253, "bedlevel": 869.4000244140625, "branchid": "pipe_9_E1130;pipe_9_E1131", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_248_generated", "shape": null, "area": 0.64, "streetlevel": 872.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 872.4000244140625, "distance_right": 3.7786232856336934e-07, "index_right": 255, "nodeid": "1386758.257366_5857606.496797", "id": "1386758.257366_5857606.496797", "name": "manhole_248_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386758.257366374600679, 5857606.496797049418092 ] } }, -{ "type": "Feature", "properties": { "_index": 254, "bedlevel": 869.4000244140625, "branchid": "pipe_9_E1131;pipe_9_E1132", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_249_generated", "shape": null, "area": 0.64, "streetlevel": 872.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 872.4000244140625, "distance_right": 3.2795260285698398e-07, "index_right": 256, "nodeid": "1386721.502390_5857640.394349", "id": "1386721.502390_5857640.394349", "name": "manhole_249_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386721.502390186069533, 5857640.394349270500243 ] } }, -{ "type": "Feature", "properties": { "_index": 255, "bedlevel": 869.4000244140625, "branchid": "pipe_9_E1132;pipe_9_E1133", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_250_generated", "shape": null, "area": 0.64, "streetlevel": 872.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 872.4000244140625, "distance_right": 4.6900674597777131e-07, "index_right": 257, "nodeid": "1386691.639095_5857680.292891", "id": "1386691.639095_5857680.292891", "name": "manhole_250_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386691.639095245627686, 5857680.292891399934888 ] } }, -{ "type": "Feature", "properties": { "_index": 256, "bedlevel": 857.70001220703125, "branchid": "pipe_9_E1133;pipe_9_E1134", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_251_generated", "shape": null, "area": 0.64, "streetlevel": 860.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 860.70001220703125, "distance_right": 3.3192243792747955e-07, "index_right": 258, "nodeid": "1386663.127201_5857721.366520", "id": "1386663.127201_5857721.366520", "name": "manhole_251_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386663.127201205352321, 5857721.366519738920033 ] } }, -{ "type": "Feature", "properties": { "_index": 257, "bedlevel": 861.10003662109375, "branchid": "pipe_9_E1134;pipe_9_E1135", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_252_generated", "shape": null, "area": 0.64, "streetlevel": 864.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 864.10003662109375, "distance_right": 5.2146766921896017e-07, "index_right": 259, "nodeid": "1386634.707845_5857762.504246", "id": "1386634.707845_5857762.504246", "name": "manhole_252_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386634.70784462057054, 5857762.504245642572641 ] } }, -{ "type": "Feature", "properties": { "_index": 258, "bedlevel": 861.10003662109375, "branchid": "pipe_9_E1135;pipe_9_E1136", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_253_generated", "shape": null, "area": 0.64, "streetlevel": 864.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 864.10003662109375, "distance_right": 4.5498759751961357e-07, "index_right": 260, "nodeid": "1386606.288488_5857803.641972", "id": "1386606.288488_5857803.641972", "name": "manhole_253_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386606.28848803602159, 5857803.64197154622525 ] } }, -{ "type": "Feature", "properties": { "_index": 259, "bedlevel": 861.10003662109375, "branchid": "pipe_9_E1136;pipe_9_E1137", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_254_generated", "shape": null, "area": 0.64, "streetlevel": 864.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 864.10003662109375, "distance_right": 2.5699989460409016e-07, "index_right": 261, "nodeid": "1386577.851668_5857844.766918", "id": "1386577.851668_5857844.766918", "name": "manhole_254_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386577.851668093586341, 5857844.766917760483921 ] } }, -{ "type": "Feature", "properties": { "_index": 260, "bedlevel": 833.10003662109375, "branchid": "pipe_9_E1137;pipe_9_E1138", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_255_generated", "shape": null, "area": 0.64, "streetlevel": 836.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 836.10003662109375, "distance_right": 4.6245863146990199e-07, "index_right": 262, "nodeid": "1386559.479124_5857890.340474", "id": "1386559.479124_5857890.340474", "name": "manhole_255_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386559.479123871540651, 5857890.340473555959761 ] } }, -{ "type": "Feature", "properties": { "_index": 261, "bedlevel": 833.10003662109375, "branchid": "pipe_9_E1138;pipe_9_E1139", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_256_generated", "shape": null, "area": 0.64, "streetlevel": 836.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 836.10003662109375, "distance_right": 5.021981574989325e-07, "index_right": 263, "nodeid": "1386576.858566_5857935.633446", "id": "1386576.858566_5857935.633446", "name": "manhole_256_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386576.858566463226452, 5857935.633445805869997 ] } }, -{ "type": "Feature", "properties": { "_index": 262, "bedlevel": 851.9000244140625, "branchid": "pipe_9_E1139;pipe_9_E1140", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_257_generated", "shape": null, "area": 0.64, "streetlevel": 854.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 854.9000244140625, "distance_right": 4.9781434926194598e-07, "index_right": 264, "nodeid": "1386619.073707_5857961.189545", "id": "1386619.073707_5857961.189545", "name": "manhole_257_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386619.073707325849682, 5857961.189545376226306 ] } }, -{ "type": "Feature", "properties": { "_index": 263, "bedlevel": 851.9000244140625, "branchid": "pipe_9_E1140;pipe_9_E1141", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_258_generated", "shape": null, "area": 0.64, "streetlevel": 854.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 854.9000244140625, "distance_right": 5.8796597557960585e-07, "index_right": 265, "nodeid": "1386664.860783_5857981.277063", "id": "1386664.860783_5857981.277063", "name": "manhole_258_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386664.860782509436831, 5857981.27706332411617 ] } }, -{ "type": "Feature", "properties": { "_index": 264, "bedlevel": 868.60003662109375, "branchid": "pipe_9_E1141;pipe_9_E1142", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_259_generated", "shape": null, "area": 0.64, "streetlevel": 871.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 871.60003662109375, "distance_right": 2.1920383756110676e-07, "index_right": 266, "nodeid": "1386710.721603_5858001.195835", "id": "1386710.721603_5858001.195835", "name": "manhole_259_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386710.721602912992239, 5858001.195835201069713 ] } }, -{ "type": "Feature", "properties": { "_index": 265, "bedlevel": 862.10003662109375, "branchid": "pipe_9_E1142;pipe_9_E1143", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_260_generated", "shape": null, "area": 0.64, "streetlevel": 865.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 865.10003662109375, "distance_right": 3.2639501446625323e-07, "index_right": 267, "nodeid": "1386756.582423_5858021.114607", "id": "1386756.582423_5858021.114607", "name": "manhole_260_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386756.582423316547647, 5858021.114607078954577 ] } }, -{ "type": "Feature", "properties": { "_index": 266, "bedlevel": 861.70001220703125, "branchid": "pipe_9_E1143;pipe_9_E1144", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_261_generated", "shape": null, "area": 0.64, "streetlevel": 864.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 864.70001220703125, "distance_right": 2.8312244562798407e-07, "index_right": 268, "nodeid": "1386802.443244_5858041.033379", "id": "1386802.443244_5858041.033379", "name": "manhole_261_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386802.443243720103055, 5858041.033378956839442 ] } }, -{ "type": "Feature", "properties": { "_index": 267, "bedlevel": 861.70001220703125, "branchid": "pipe_9_E1144;pipe_9_E1145", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_262_generated", "shape": null, "area": 0.64, "streetlevel": 864.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 864.70001220703125, "distance_right": 2.0605511963367462e-07, "index_right": 269, "nodeid": "1386848.304064_5858060.952151", "id": "1386848.304064_5858060.952151", "name": "manhole_262_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386848.304064123658463, 5858060.952150834724307 ] } }, -{ "type": "Feature", "properties": { "_index": 268, "bedlevel": 856.20001220703125, "branchid": "pipe_9_E1145;pipe_9_E1146", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_263_generated", "shape": null, "area": 0.64, "streetlevel": 859.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 859.20001220703125, "distance_right": 2.7649861880441913e-07, "index_right": 270, "nodeid": "1386892.843548_5858083.471455", "id": "1386892.843548_5858083.471455", "name": "manhole_263_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386892.843548113014549, 5858083.471454747952521 ] } }, -{ "type": "Feature", "properties": { "_index": 269, "bedlevel": 856.20001220703125, "branchid": "pipe_9_E1146;pipe_9_E1147", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_264_generated", "shape": null, "area": 0.64, "streetlevel": 859.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 859.20001220703125, "distance_right": 3.0590260754863043e-07, "index_right": 271, "nodeid": "1386931.443848_5858115.251782", "id": "1386931.443848_5858115.251782", "name": "manhole_264_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386931.443847785238177, 5858115.251781782135367 ] } }, -{ "type": "Feature", "properties": { "_index": 270, "bedlevel": 850.60003662109375, "branchid": "pipe_9_E1147;pipe_9_E1148", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_265_generated", "shape": null, "area": 0.64, "streetlevel": 853.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 853.60003662109375, "distance_right": 4.9236673697818464e-07, "index_right": 272, "nodeid": "1386970.044147_5858147.032109", "id": "1386970.044147_5858147.032109", "name": "manhole_265_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386970.044147457228974, 5858147.032108817249537 ] } }, -{ "type": "Feature", "properties": { "_index": 271, "bedlevel": 850.60003662109375, "branchid": "pipe_9_E1148;pipe_9_E1149", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_266_generated", "shape": null, "area": 0.64, "streetlevel": 853.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 853.60003662109375, "distance_right": 1.9738985949682692e-07, "index_right": 273, "nodeid": "1387008.644447_5858178.812436", "id": "1387008.644447_5858178.812436", "name": "manhole_266_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387008.644447129452601, 5858178.812435851432383 ] } }, -{ "type": "Feature", "properties": { "_index": 272, "bedlevel": 839.4000244140625, "branchid": "pipe_9_E1149;pipe_9_E1150", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_267_generated", "shape": null, "area": 0.64, "streetlevel": 842.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 842.4000244140625, "distance_right": 2.2880903617256829e-07, "index_right": 274, "nodeid": "1387047.244747_5858210.592763", "id": "1387047.244747_5858210.592763", "name": "manhole_267_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387047.244746801443398, 5858210.592762886546552 ] } }, -{ "type": "Feature", "properties": { "_index": 273, "bedlevel": 839.4000244140625, "branchid": "pipe_9_E1150;pipe_9_E1151", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_268_generated", "shape": null, "area": 0.64, "streetlevel": 842.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 842.4000244140625, "distance_right": 4.8014827367443299e-07, "index_right": 275, "nodeid": "1387085.845046_5858242.373090", "id": "1387085.845046_5858242.373090", "name": "manhole_268_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387085.845046473667026, 5858242.373089920729399 ] } }, -{ "type": "Feature", "properties": { "_index": 274, "bedlevel": 839.4000244140625, "branchid": "pipe_9_E1151;pipe_9_E1152", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_269_generated", "shape": null, "area": 0.64, "streetlevel": 842.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 842.4000244140625, "distance_right": 1.5218292481899163e-07, "index_right": 276, "nodeid": "1387124.445346_5858274.153417", "id": "1387124.445346_5858274.153417", "name": "manhole_269_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387124.445346145657822, 5858274.153416955843568 ] } }, -{ "type": "Feature", "properties": { "_index": 275, "bedlevel": 824.60003662109375, "branchid": "pipe_9_E1152;pipe_9_E1153", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_270_generated", "shape": null, "area": 0.64, "streetlevel": 827.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 827.60003662109375, "distance_right": 1.8236154538895495e-07, "index_right": 277, "nodeid": "1387163.045646_5858305.933744", "id": "1387163.045646_5858305.933744", "name": "manhole_270_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387163.04564581788145, 5858305.933743990026414 ] } }, -{ "type": "Feature", "properties": { "_index": 276, "bedlevel": 824.60003662109375, "branchid": "pipe_9_E1153;pipe_9_E1154", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_271_generated", "shape": null, "area": 0.64, "streetlevel": 827.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 827.60003662109375, "distance_right": 1.9809660257622753e-07, "index_right": 278, "nodeid": "1387201.829349_5858337.489215", "id": "1387201.829349_5858337.489215", "name": "manhole_271_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387201.829349192325026, 5858337.489215047098696 ] } }, -{ "type": "Feature", "properties": { "_index": 277, "bedlevel": 834.60003662109375, "branchid": "pipe_9_E1154;pipe_9_E1155", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_272_generated", "shape": null, "area": 0.64, "streetlevel": 837.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 837.60003662109375, "distance_right": 3.1535765417261081e-07, "index_right": 279, "nodeid": "1387246.200623_5858359.687652", "id": "1387246.200623_5858359.687652", "name": "manhole_272_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387246.200623227981851, 5858359.687651782296598 ] } }, -{ "type": "Feature", "properties": { "_index": 278, "bedlevel": 834.60003662109375, "branchid": "pipe_9_E1155;pipe_9_E1156", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_273_generated", "shape": null, "area": 0.64, "streetlevel": 837.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 837.60003662109375, "distance_right": 3.7290166354514342e-07, "index_right": 280, "nodeid": "1387293.201938_5858376.741939", "id": "1387293.201938_5858376.741939", "name": "manhole_273_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387293.201938283629715, 5858376.741938757710159 ] } }, -{ "type": "Feature", "properties": { "_index": 279, "bedlevel": 840.79998779296875, "branchid": "pipe_9_E1156;pipe_9_E1157", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_274_generated", "shape": null, "area": 0.64, "streetlevel": 843.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 843.79998779296875, "distance_right": 4.6077813805798978e-07, "index_right": 281, "nodeid": "1387334.200528_5858401.732468", "id": "1387334.200528_5858401.732468", "name": "manhole_274_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387334.200528149493039, 5858401.732468435540795 ] } }, -{ "type": "Feature", "properties": { "_index": 280, "bedlevel": 819.60003662109375, "branchid": "pipe_9_E1157;pipe_9_E1158", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_275_generated", "shape": null, "area": 0.64, "streetlevel": 822.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 822.60003662109375, "distance_right": 8.5382524018633532e-08, "index_right": 282, "nodeid": "1387307.843875_5858437.110806", "id": "1387307.843875_5858437.110806", "name": "manhole_275_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387307.843875054037198, 5858437.110805934295058 ] } }, -{ "type": "Feature", "properties": { "_index": 281, "bedlevel": 819.60003662109375, "branchid": "pipe_9_E1158;pipe_9_E1159", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_276_generated", "shape": null, "area": 0.64, "streetlevel": 822.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 822.60003662109375, "distance_right": 4.2349814041677047e-07, "index_right": 283, "nodeid": "1387260.279569_5858425.045736", "id": "1387260.279569_5858425.045736", "name": "manhole_276_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387260.279569417703897, 5858425.045736069791019 ] } }, -{ "type": "Feature", "properties": { "_index": 282, "bedlevel": 824.60003662109375, "branchid": "pipe_9_E1159;pipe_9_E1160", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_277_generated", "shape": null, "area": 0.64, "streetlevel": 827.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 827.60003662109375, "distance_right": 1.9456452023223653e-07, "index_right": 284, "nodeid": "1387211.448235_5858414.300555", "id": "1387211.448235_5858414.300555", "name": "manhole_277_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387211.448235018178821, 5858414.300554806366563 ] } }, -{ "type": "Feature", "properties": { "_index": 283, "bedlevel": 824.60003662109375, "branchid": "pipe_9_E1160;pipe_9_E1161", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_278_generated", "shape": null, "area": 0.64, "streetlevel": 827.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 827.60003662109375, "distance_right": 5.9301123926818533e-07, "index_right": 285, "nodeid": "1387162.612192_5858403.576135", "id": "1387162.612192_5858403.576135", "name": "manhole_278_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387162.612191663123667, 5858403.576134512200952 ] } }, -{ "type": "Feature", "properties": { "_index": 284, "bedlevel": 819.29998779296875, "branchid": "pipe_9_E1161;pipe_9_E1162", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_279_generated", "shape": null, "area": 0.64, "streetlevel": 822.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 822.29998779296875, "distance_right": 4.6731291105077109e-07, "index_right": 286, "nodeid": "1387113.700151_5858393.210483", "id": "1387113.700151_5858393.210483", "name": "manhole_279_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387113.700150535441935, 5858393.210482948459685 ] } }, -{ "type": "Feature", "properties": { "_index": 285, "bedlevel": 819.29998779296875, "branchid": "pipe_9_E1162;pipe_9_E1163", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_280_generated", "shape": null, "area": 0.64, "streetlevel": 822.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 822.29998779296875, "distance_right": 4.0153296690850306e-07, "index_right": 287, "nodeid": "1387064.993171_5858381.975642", "id": "1387064.993171_5858381.975642", "name": "manhole_280_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387064.993171223672107, 5858381.975642333738506 ] } }, -{ "type": "Feature", "properties": { "_index": 286, "bedlevel": 824.79998779296875, "branchid": "pipe_9_E1163;pipe_9_E1164", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_281_generated", "shape": null, "area": 0.64, "streetlevel": 827.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 827.79998779296875, "distance_right": 4.0215514115362912e-07, "index_right": 288, "nodeid": "1387015.796387_5858376.342008", "id": "1387015.796387_5858376.342008", "name": "manhole_281_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387015.796386598376557, 5858376.342007979750633 ] } }, -{ "type": "Feature", "properties": { "_index": 287, "bedlevel": 824.79998779296875, "branchid": "pipe_9_E1164;pipe_9_E1165", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_282_generated", "shape": null, "area": 0.64, "streetlevel": 827.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 827.79998779296875, "distance_right": 4.3499145420040634e-07, "index_right": 289, "nodeid": "1386966.208506_5858382.746259", "id": "1386966.208506_5858382.746259", "name": "manhole_282_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386966.208506174152717, 5858382.746259398758411 ] } }, -{ "type": "Feature", "properties": { "_index": 288, "bedlevel": 830.9000244140625, "branchid": "pipe_9_E1165;pipe_9_E1166", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_283_generated", "shape": null, "area": 0.64, "streetlevel": 833.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 833.9000244140625, "distance_right": 4.8373153624010088e-07, "index_right": 290, "nodeid": "1386916.676812_5858389.559526", "id": "1386916.676812_5858389.559526", "name": "manhole_283_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386916.676812386140227, 5858389.559525708667934 ] } }, -{ "type": "Feature", "properties": { "_index": 289, "bedlevel": 830.9000244140625, "branchid": "pipe_9_E1166;pipe_9_E1167", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_284_generated", "shape": null, "area": 0.64, "streetlevel": 833.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 833.9000244140625, "distance_right": 4.8908646858358934e-07, "index_right": 291, "nodeid": "1386867.198861_5858396.764011", "id": "1386867.198861_5858396.764011", "name": "manhole_284_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386867.198860567295924, 5858396.764010772109032 ] } }, -{ "type": "Feature", "properties": { "_index": 290, "bedlevel": 830.20001220703125, "branchid": "pipe_9_E1167;pipe_9_E1168", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_285_generated", "shape": null, "area": 0.64, "streetlevel": 833.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 833.20001220703125, "distance_right": 1.7726120334507922e-07, "index_right": 292, "nodeid": "1386820.816385_5858411.854354", "id": "1386820.816385_5858411.854354", "name": "manhole_285_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386820.816385147860274, 5858411.854353901930153 ] } }, -{ "type": "Feature", "properties": { "_index": 291, "bedlevel": 806.60003662109375, "branchid": "pipe_9_E1168;pipe_9_E1169", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_286_generated", "shape": null, "area": 0.64, "streetlevel": 809.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 809.60003662109375, "distance_right": 3.1442733213135406e-07, "index_right": 293, "nodeid": "1386841.361235_5858445.514384", "id": "1386841.361235_5858445.514384", "name": "manhole_286_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386841.361234750133008, 5858445.514383808709681 ] } }, -{ "type": "Feature", "properties": { "_index": 292, "bedlevel": 806.79998779296875, "branchid": "pipe_9_E1169;pipe_9_E1170", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_287_generated", "shape": null, "area": 0.64, "streetlevel": 809.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 809.79998779296875, "distance_right": 1.0385212439389687e-07, "index_right": 294, "nodeid": "1386890.796275_5858452.915635", "id": "1386890.796275_5858452.915635", "name": "manhole_287_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386890.796275103231892, 5858452.915634987875819 ] } }, -{ "type": "Feature", "properties": { "_index": 293, "bedlevel": 806.79998779296875, "branchid": "pipe_9_E1170;pipe_9_E1171", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_288_generated", "shape": null, "area": 0.64, "streetlevel": 809.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 809.79998779296875, "distance_right": 3.6124182714980252e-07, "index_right": 295, "nodeid": "1386940.277141_5858460.100081", "id": "1386940.277141_5858460.100081", "name": "manhole_288_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386940.277140651131049, 5858460.100081093609333 ] } }, -{ "type": "Feature", "properties": { "_index": 294, "bedlevel": 802.4000244140625, "branchid": "pipe_9_E1171;pipe_9_E1172", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_289_generated", "shape": null, "area": 0.64, "streetlevel": 805.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 805.4000244140625, "distance_right": 5.0630815568272578e-07, "index_right": 296, "nodeid": "1386989.847998_5858466.483407", "id": "1386989.847998_5858466.483407", "name": "manhole_289_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386989.847997799050063, 5858466.483407464809716 ] } }, -{ "type": "Feature", "properties": { "_index": 295, "bedlevel": 802.4000244140625, "branchid": "pipe_9_E1172;pipe_9_E1173", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_290_generated", "shape": null, "area": 0.64, "streetlevel": 805.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 805.4000244140625, "distance_right": 5.2372736805822677e-07, "index_right": 297, "nodeid": "1387039.689649_5858470.456085", "id": "1387039.689649_5858470.456085", "name": "manhole_290_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387039.689648573985323, 5858470.45608530472964 ] } }, -{ "type": "Feature", "properties": { "_index": 296, "bedlevel": 801.60003662109375, "branchid": "pipe_9_E1173;pipe_9_E1174", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_291_generated", "shape": null, "area": 0.64, "streetlevel": 804.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 804.60003662109375, "distance_right": 1.5993024886383644e-07, "index_right": 298, "nodeid": "1387088.843806_5858479.424947", "id": "1387088.843806_5858479.424947", "name": "manhole_291_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387088.843806148739532, 5858479.424946941435337 ] } }, -{ "type": "Feature", "properties": { "_index": 297, "bedlevel": 806.9000244140625, "branchid": "pipe_9_E1174;pipe_9_E1175", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_292_generated", "shape": null, "area": 0.64, "streetlevel": 809.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 809.9000244140625, "distance_right": 3.7517997879668708e-07, "index_right": 299, "nodeid": "1387137.906045_5858489.061807", "id": "1387137.906045_5858489.061807", "name": "manhole_292_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387137.90604472765699, 5858489.061806742101908 ] } }, -{ "type": "Feature", "properties": { "_index": 298, "bedlevel": 806.9000244140625, "branchid": "pipe_9_E1175;pipe_9_E1176", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_293_generated", "shape": null, "area": 0.64, "streetlevel": 809.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 809.9000244140625, "distance_right": 3.6405332731419796e-07, "index_right": 300, "nodeid": "1387186.336530_5858500.879681", "id": "1387186.336530_5858500.879681", "name": "manhole_293_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387186.336529975291342, 5858500.87968063633889 ] } }, -{ "type": "Feature", "properties": { "_index": 299, "bedlevel": 819.60003662109375, "branchid": "pipe_9_E1176;pipe_9_E1177", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_294_generated", "shape": null, "area": 0.64, "streetlevel": 822.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 822.60003662109375, "distance_right": 4.7023029237319848e-07, "index_right": 301, "nodeid": "1387231.661051_5858521.423060", "id": "1387231.661051_5858521.423060", "name": "manhole_294_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387231.661050535272807, 5858521.423059928230941 ] } }, -{ "type": "Feature", "properties": { "_index": 300, "bedlevel": 784.70001220703125, "branchid": "pipe_9_E1177;pipe_9_E1178", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_295_generated", "shape": null, "area": 0.64, "streetlevel": 787.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 787.70001220703125, "distance_right": 3.9755428442383632e-07, "index_right": 302, "nodeid": "1387268.120025_5858555.035049", "id": "1387268.120025_5858555.035049", "name": "manhole_295_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387268.120024613803253, 5858555.03504909388721 ] } }, -{ "type": "Feature", "properties": { "_index": 301, "bedlevel": 784.70001220703125, "branchid": "pipe_9_E1178;pipe_9_E1179", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_296_generated", "shape": null, "area": 0.64, "streetlevel": 787.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 787.70001220703125, "distance_right": 5.1789956777309593e-07, "index_right": 303, "nodeid": "1387300.917169_5858592.775208", "id": "1387300.917169_5858592.775208", "name": "manhole_296_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387300.917169471969828, 5858592.775208213366568 ] } }, -{ "type": "Feature", "properties": { "_index": 302, "bedlevel": 794.10003662109375, "branchid": "pipe_9_E1179;pipe_9_E1180", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_297_generated", "shape": null, "area": 0.64, "streetlevel": 797.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 797.10003662109375, "distance_right": 3.1601800580138037e-07, "index_right": 304, "nodeid": "1387340.521647_5858622.315198", "id": "1387340.521647_5858622.315198", "name": "manhole_297_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387340.521646688459441, 5858622.315198052674532 ] } }, -{ "type": "Feature", "properties": { "_index": 303, "bedlevel": 794.10003662109375, "branchid": "pipe_9_E1180;pipe_9_E1181", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_298_generated", "shape": null, "area": 0.64, "streetlevel": 797.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 797.10003662109375, "distance_right": 5.0820743069320088e-07, "index_right": 305, "nodeid": "1387387.476920_5858639.495844", "id": "1387387.476920_5858639.495844", "name": "manhole_298_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387387.476920192595571, 5858639.495844470337033 ] } }, -{ "type": "Feature", "properties": { "_index": 304, "bedlevel": 803.10003662109375, "branchid": "pipe_9_E1181;pipe_9_E1182", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_299_generated", "shape": null, "area": 0.64, "streetlevel": 806.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 806.10003662109375, "distance_right": 6.6801801863117119e-07, "index_right": 306, "nodeid": "1387436.116963_5858650.828613", "id": "1387436.116963_5858650.828613", "name": "manhole_299_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387436.116963447071612, 5858650.82861250359565 ] } }, -{ "type": "Feature", "properties": { "_index": 305, "bedlevel": 803.10003662109375, "branchid": "pipe_9_E1182;pipe_9_E1183", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_300_generated", "shape": null, "area": 0.64, "streetlevel": 806.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 806.10003662109375, "distance_right": 5.6479670540947805e-07, "index_right": 307, "nodeid": "1387485.194104_5858660.261458", "id": "1387485.194104_5858660.261458", "name": "manhole_300_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387485.194103535497561, 5858660.261457678861916 ] } }, -{ "type": "Feature", "properties": { "_index": 306, "bedlevel": 804.70001220703125, "branchid": "pipe_9_E1183;pipe_9_E1184", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_301_generated", "shape": null, "area": 0.64, "streetlevel": 807.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.70001220703125, "distance_right": 4.4892163287133709e-07, "index_right": 308, "nodeid": "1387533.804190_5858671.493854", "id": "1387533.804190_5858671.493854", "name": "manhole_301_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387533.804190448950976, 5858671.493853995576501 ] } }, -{ "type": "Feature", "properties": { "_index": 307, "bedlevel": 769.20001220703125, "branchid": "pipe_9_E1184;pipe_9_E1185", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_302_generated", "shape": null, "area": 0.64, "streetlevel": 772.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 772.20001220703125, "distance_right": 3.8060938621151436e-07, "index_right": 309, "nodeid": "1387580.296834_5858689.619015", "id": "1387580.296834_5858689.619015", "name": "manhole_302_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387580.2968336828053, 5858689.619015210308135 ] } }, -{ "type": "Feature", "properties": { "_index": 308, "bedlevel": 775.79998779296875, "branchid": "pipe_9_E1185;pipe_9_E1186", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_303_generated", "shape": null, "area": 0.64, "streetlevel": 778.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 778.79998779296875, "distance_right": 1.987741082007922e-07, "index_right": 310, "nodeid": "1387628.455277_5858703.062848", "id": "1387628.455277_5858703.062848", "name": "manhole_303_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387628.455277157016098, 5858703.062848121859133 ] } }, -{ "type": "Feature", "properties": { "_index": 309, "bedlevel": 775.79998779296875, "branchid": "pipe_9_E1186;pipe_9_E1187", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_304_generated", "shape": null, "area": 0.64, "streetlevel": 778.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 778.79998779296875, "distance_right": 1.0050088277659534e-07, "index_right": 311, "nodeid": "1387677.211432_5858713.786249", "id": "1387677.211432_5858713.786249", "name": "manhole_304_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387677.211432087467983, 5858713.7862489502877 ] } }, -{ "type": "Feature", "properties": { "_index": 310, "bedlevel": 783.70001220703125, "branchid": "pipe_9_E1187;pipe_9_E1188", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_305_generated", "shape": null, "area": 0.64, "streetlevel": 786.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 786.70001220703125, "distance_right": 2.8897612857941058e-07, "index_right": 312, "nodeid": "1387726.995392_5858712.747127", "id": "1387726.995392_5858712.747127", "name": "manhole_305_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387726.995392211945727, 5858712.747126803733408 ] } }, -{ "type": "Feature", "properties": { "_index": 311, "bedlevel": 783.70001220703125, "branchid": "pipe_9_E1188;pipe_9_E1189", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_306_generated", "shape": null, "area": 0.64, "streetlevel": 786.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 786.70001220703125, "distance_right": 4.773026491265167e-07, "index_right": 313, "nodeid": "1387773.343349_5858725.014478", "id": "1387773.343349_5858725.014478", "name": "manhole_306_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387773.343349169706926, 5858725.014477553777397 ] } }, -{ "type": "Feature", "properties": { "_index": 312, "bedlevel": 794.70001220703125, "branchid": "pipe_9_E1189;pipe_9_E1190", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_307_generated", "shape": null, "area": 0.64, "streetlevel": 797.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 797.70001220703125, "distance_right": 5.0487611162469514e-07, "index_right": 314, "nodeid": "1387806.363672_5858762.310494", "id": "1387806.363672_5858762.310494", "name": "manhole_307_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387806.363672176143155, 5858762.310494473204017 ] } }, -{ "type": "Feature", "properties": { "_index": 313, "bedlevel": 794.70001220703125, "branchid": "pipe_9_E1190;pipe_9_E1191", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_308_generated", "shape": null, "area": 0.64, "streetlevel": 797.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 797.70001220703125, "distance_right": 3.7741157887003312e-07, "index_right": 315, "nodeid": "1387799.717028_5858810.149600", "id": "1387799.717028_5858810.149600", "name": "manhole_308_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387799.717027904232964, 5858810.149600365199149 ] } }, -{ "type": "Feature", "properties": { "_index": 314, "bedlevel": 749.70001220703125, "branchid": "pipe_9_E1191;pipe_9_E1192", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_309_generated", "shape": null, "area": 0.64, "streetlevel": 752.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 752.70001220703125, "distance_right": 3.5034815396929229e-07, "index_right": 316, "nodeid": "1387771.971140_5858850.861094", "id": "1387771.971140_5858850.861094", "name": "manhole_309_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387771.971139753237367, 5858850.86109375115484 ] } }, -{ "type": "Feature", "properties": { "_index": 315, "bedlevel": 749.70001220703125, "branchid": "pipe_9_E1192;pipe_9_E1193", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_310_generated", "shape": null, "area": 0.64, "streetlevel": 752.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 752.70001220703125, "distance_right": 3.0946021768837125e-07, "index_right": 317, "nodeid": "1387723.076751_5858854.679318", "id": "1387723.076751_5858854.679318", "name": "manhole_310_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387723.07675126590766, 5858854.679317841306329 ] } }, -{ "type": "Feature", "properties": { "_index": 316, "bedlevel": 749.70001220703125, "branchid": "pipe_9_E1193;pipe_9_E1194", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_311_generated", "shape": null, "area": 0.64, "streetlevel": 752.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 752.70001220703125, "distance_right": 2.4466856167220514e-07, "index_right": 318, "nodeid": "1387673.274138_5858850.996178", "id": "1387673.274138_5858850.996178", "name": "manhole_311_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387673.274138238513842, 5858850.996178055182099 ] } }, -{ "type": "Feature", "properties": { "_index": 317, "bedlevel": 749.70001220703125, "branchid": "pipe_9_E1194;pipe_9_E1195", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_312_generated", "shape": null, "area": 0.64, "streetlevel": 752.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 752.70001220703125, "distance_right": 4.8731809691594117e-07, "index_right": 319, "nodeid": "1387624.170363_5858858.384703", "id": "1387624.170363_5858858.384703", "name": "manhole_312_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387624.170362570788711, 5858858.384703231044114 ] } }, -{ "type": "Feature", "properties": { "_index": 318, "bedlevel": 749.70001220703125, "branchid": "pipe_9_E1195;pipe_9_E1196", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_313_generated", "shape": null, "area": 0.64, "streetlevel": 752.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 752.70001220703125, "distance_right": 3.021208853052767e-07, "index_right": 320, "nodeid": "1387575.715394_5858857.046076", "id": "1387575.715394_5858857.046076", "name": "manhole_313_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387575.715393897145987, 5858857.046076283790171 ] } }, -{ "type": "Feature", "properties": { "_index": 319, "bedlevel": 749.70001220703125, "branchid": "pipe_9_E1196;pipe_9_E1197", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_314_generated", "shape": null, "area": 0.64, "streetlevel": 752.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 752.70001220703125, "distance_right": 4.4818126936430864e-07, "index_right": 321, "nodeid": "1387529.438333_5858838.116818", "id": "1387529.438333_5858838.116818", "name": "manhole_314_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387529.438332577701658, 5858838.116818149574101 ] } }, -{ "type": "Feature", "properties": { "_index": 320, "bedlevel": 749.70001220703125, "branchid": "pipe_9_E1197;pipe_9_E1198", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_315_generated", "shape": null, "area": 0.64, "streetlevel": 752.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 752.70001220703125, "distance_right": 5.6845137939870927e-07, "index_right": 322, "nodeid": "1387481.179235_5858825.222028", "id": "1387481.179235_5858825.222028", "name": "manhole_315_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387481.179235466290265, 5858825.222027675248682 ] } }, -{ "type": "Feature", "properties": { "_index": 321, "bedlevel": 774.20001220703125, "branchid": "pipe_9_E1198;pipe_9_E1199", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_316_generated", "shape": null, "area": 0.64, "streetlevel": 777.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 777.20001220703125, "distance_right": 3.6917873843020322e-07, "index_right": 323, "nodeid": "1387432.215501_5858815.797907", "id": "1387432.215501_5858815.797907", "name": "manhole_316_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387432.215501294471323, 5858815.797906777821481 ] } }, -{ "type": "Feature", "properties": { "_index": 322, "bedlevel": 769.79998779296875, "branchid": "pipe_9_E1199;pipe_9_E1200", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_317_generated", "shape": null, "area": 0.64, "streetlevel": 772.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 772.79998779296875, "distance_right": 4.8304048875277775e-07, "index_right": 324, "nodeid": "1387382.431882_5858811.154251", "id": "1387382.431882_5858811.154251", "name": "manhole_317_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387382.431881646160036, 5858811.154251328669488 ] } }, -{ "type": "Feature", "properties": { "_index": 323, "bedlevel": 744.10003662109375, "branchid": "pipe_9_E1200;pipe_9_E1201", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_318_generated", "shape": null, "area": 0.64, "streetlevel": 747.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 747.10003662109375, "distance_right": 4.6235358904885766e-07, "index_right": 325, "nodeid": "1387336.607073_5858824.075685", "id": "1387336.607073_5858824.075685", "name": "manhole_318_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387336.607072548242286, 5858824.075685098767281 ] } }, -{ "type": "Feature", "properties": { "_index": 324, "bedlevel": 744.10003662109375, "branchid": "pipe_9_E1201;pipe_9_E1202", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_319_generated", "shape": null, "area": 0.64, "streetlevel": 747.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 747.10003662109375, "distance_right": 5.6873244460004577e-07, "index_right": 326, "nodeid": "1387327.458137_5858870.885960", "id": "1387327.458137_5858870.885960", "name": "manhole_319_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387327.458137275883928, 5858870.88596049696207 ] } }, -{ "type": "Feature", "properties": { "_index": 325, "bedlevel": 744.10003662109375, "branchid": "pipe_9_E1202;pipe_9_E1203", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_320_generated", "shape": null, "area": 0.64, "streetlevel": 747.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 747.10003662109375, "distance_right": 3.8904049800083803e-07, "index_right": 327, "nodeid": "1387344.619252_5858917.848376", "id": "1387344.619252_5858917.848376", "name": "manhole_320_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387344.619252334116027, 5858917.848375800997019 ] } }, -{ "type": "Feature", "properties": { "_index": 326, "bedlevel": 770.70001220703125, "branchid": "pipe_9_E1203;pipe_9_E1204", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_321_generated", "shape": null, "area": 0.64, "streetlevel": 773.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 773.70001220703125, "distance_right": 5.1999605945586677e-07, "index_right": 328, "nodeid": "1387358.089984_5858965.710650", "id": "1387358.089984_5858965.710650", "name": "manhole_321_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387358.089983508689329, 5858965.710649829357862 ] } }, -{ "type": "Feature", "properties": { "_index": 327, "bedlevel": 770.70001220703125, "branchid": "pipe_9_E1204;pipe_9_E1205", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_322_generated", "shape": null, "area": 0.64, "streetlevel": 773.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 773.70001220703125, "distance_right": 4.9281359962432306e-07, "index_right": 329, "nodeid": "1387329.564613_5859003.583583", "id": "1387329.564613_5859003.583583", "name": "manhole_322_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387329.564612702699378, 5859003.583583393134177 ] } }, -{ "type": "Feature", "properties": { "_index": 328, "bedlevel": 771.29998779296875, "branchid": "pipe_9_E1205;pipe_9_E1206", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_323_generated", "shape": null, "area": 0.64, "streetlevel": 774.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 774.29998779296875, "distance_right": 3.9854077696941929e-07, "index_right": 330, "nodeid": "1387285.783744_5858993.703192", "id": "1387285.783744_5858993.703192", "name": "manhole_323_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387285.783744251355529, 5858993.703191691078246 ] } }, -{ "type": "Feature", "properties": { "_index": 329, "bedlevel": 771.29998779296875, "branchid": "pipe_9_E1206;pipe_9_E1207", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_324_generated", "shape": null, "area": 0.64, "streetlevel": 774.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 774.29998779296875, "distance_right": 1.835562136038822e-07, "index_right": 331, "nodeid": "1387248.355973_5858961.317975", "id": "1387248.355973_5858961.317975", "name": "manhole_324_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387248.355973182013258, 5858961.31797497626394 ] } }, -{ "type": "Feature", "properties": { "_index": 330, "bedlevel": 766.4000244140625, "branchid": "pipe_9_E1207;pipe_9_E1208", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_325_generated", "shape": null, "area": 0.64, "streetlevel": 769.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 769.4000244140625, "distance_right": 5.4534265143731815e-07, "index_right": 332, "nodeid": "1387199.500434_5858963.645902", "id": "1387199.500434_5858963.645902", "name": "manhole_325_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387199.500433639157563, 5858963.645901591517031 ] } }, -{ "type": "Feature", "properties": { "_index": 331, "bedlevel": 766.4000244140625, "branchid": "pipe_9_E1208;pipe_9_E1209", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_326_generated", "shape": null, "area": 0.64, "streetlevel": 769.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 769.4000244140625, "distance_right": 2.0016300260355049e-07, "index_right": 333, "nodeid": "1387151.482699_5858977.583961", "id": "1387151.482699_5858977.583961", "name": "manhole_326_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387151.482699199579656, 5858977.583961015567183 ] } }, -{ "type": "Feature", "properties": { "_index": 332, "bedlevel": 759.60003662109375, "branchid": "pipe_9_E1209;pipe_9_E1210", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_327_generated", "shape": null, "area": 0.64, "streetlevel": 762.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.60003662109375, "distance_right": 4.0229854171678003e-07, "index_right": 334, "nodeid": "1387103.632612_5858992.082135", "id": "1387103.632612_5858992.082135", "name": "manhole_327_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387103.632611613254994, 5858992.082134889438748 ] } }, -{ "type": "Feature", "properties": { "_index": 333, "bedlevel": 759.60003662109375, "branchid": "pipe_9_E1210;pipe_9_E1211", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_328_generated", "shape": null, "area": 0.64, "streetlevel": 762.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.60003662109375, "distance_right": 4.915098453471915e-07, "index_right": 335, "nodeid": "1387055.853340_5859006.816906", "id": "1387055.853340_5859006.816906", "name": "manhole_328_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387055.853339510038495, 5859006.816905959509313 ] } }, -{ "type": "Feature", "properties": { "_index": 334, "bedlevel": 752.79998779296875, "branchid": "pipe_9_E1211;pipe_9_E1212", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_329_generated", "shape": null, "area": 0.64, "streetlevel": 755.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 755.79998779296875, "distance_right": 4.0761325042562238e-07, "index_right": 336, "nodeid": "1387008.074067_5859021.551677", "id": "1387008.074067_5859021.551677", "name": "manhole_329_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387008.074067406589165, 5859021.551677029579878 ] } }, -{ "type": "Feature", "properties": { "_index": 335, "bedlevel": 752.79998779296875, "branchid": "pipe_9_E1212;pipe_9_E1213", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_330_generated", "shape": null, "area": 0.64, "streetlevel": 755.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 755.79998779296875, "distance_right": 3.1932559379339034e-07, "index_right": 337, "nodeid": "1386960.294795_5859036.286448", "id": "1386960.294795_5859036.286448", "name": "manhole_330_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386960.294795303372666, 5859036.286448099650443 ] } }, -{ "type": "Feature", "properties": { "_index": 336, "bedlevel": 746.5, "branchid": "pipe_9_E1213;pipe_9_E1214", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_331_generated", "shape": null, "area": 0.64, "streetlevel": 749.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 749.5, "distance_right": 2.6234383268459319e-07, "index_right": 338, "nodeid": "1386912.515523_5859051.021219", "id": "1386912.515523_5859051.021219", "name": "manhole_331_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386912.515523200156167, 5859051.021219169721007 ] } }, -{ "type": "Feature", "properties": { "_index": 337, "bedlevel": 746.5, "branchid": "pipe_9_E1214;pipe_9_E1215", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_332_generated", "shape": null, "area": 0.64, "streetlevel": 749.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 749.5, "distance_right": 2.5811763091701403e-07, "index_right": 339, "nodeid": "1386864.736251_5859065.755990", "id": "1386864.736251_5859065.755990", "name": "manhole_332_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386864.736251096706837, 5859065.755990239791572 ] } }, -{ "type": "Feature", "properties": { "_index": 338, "bedlevel": 724.10003662109375, "branchid": "pipe_9_E1215;pipe_9_E1216", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_333_generated", "shape": null, "area": 0.64, "streetlevel": 727.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 727.10003662109375, "distance_right": 3.1019893050904853e-07, "index_right": 340, "nodeid": "1386816.956979_5859080.490761", "id": "1386816.956979_5859080.490761", "name": "manhole_333_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386816.956978993490338, 5859080.490761309862137 ] } }, -{ "type": "Feature", "properties": { "_index": 339, "bedlevel": 749.29998779296875, "branchid": "pipe_9_E1216;pipe_9_E1217", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_334_generated", "shape": null, "area": 0.64, "streetlevel": 752.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 752.29998779296875, "distance_right": 5.6178406168264699e-07, "index_right": 341, "nodeid": "1386769.832018_5859096.976014", "id": "1386769.832018_5859096.976014", "name": "manhole_334_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386769.832018451532349, 5859096.976014334708452 ] } }, -{ "type": "Feature", "properties": { "_index": 340, "bedlevel": 735.0, "branchid": "pipe_9_E1217;pipe_9_E1218", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_335_generated", "shape": null, "area": 0.64, "streetlevel": 738.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 738.0, "distance_right": 2.8621809563681197e-07, "index_right": 342, "nodeid": "1386724.102283_5859117.193917", "id": "1386724.102283_5859117.193917", "name": "manhole_335_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386724.102282747160643, 5859117.193917133845389 ] } }, -{ "type": "Feature", "properties": { "_index": 341, "bedlevel": 735.0, "branchid": "pipe_9_E1218;pipe_9_E1219", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_336_generated", "shape": null, "area": 0.64, "streetlevel": 738.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 738.0, "distance_right": 7.8789009124261769e-08, "index_right": 343, "nodeid": "1386678.372547_5859137.411820", "id": "1386678.372547_5859137.411820", "name": "manhole_336_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386678.372547042788938, 5859137.411819933913648 ] } }, -{ "type": "Feature", "properties": { "_index": 342, "bedlevel": 729.79998779296875, "branchid": "pipe_9_E1219;pipe_9_E1220", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_337_generated", "shape": null, "area": 0.64, "streetlevel": 732.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 732.79998779296875, "distance_right": 4.3115262751711752e-07, "index_right": 344, "nodeid": "1386632.642811_5859157.629723", "id": "1386632.642811_5859157.629723", "name": "manhole_337_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386632.642811338417232, 5859157.629722733050585 ] } }, -{ "type": "Feature", "properties": { "_index": 343, "bedlevel": 729.79998779296875, "branchid": "pipe_9_E1220;pipe_9_E1221", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_338_generated", "shape": null, "area": 0.64, "streetlevel": 732.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 732.79998779296875, "distance_right": 5.9301923802470201e-07, "index_right": 345, "nodeid": "1386586.913076_5859177.847626", "id": "1386586.913076_5859177.847626", "name": "manhole_338_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386586.913075634045526, 5859177.847625533118844 ] } }, -{ "type": "Feature", "properties": { "_index": 344, "bedlevel": 729.60003662109375, "branchid": "pipe_9_E1221;pipe_9_E1222", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_339_generated", "shape": null, "area": 0.64, "streetlevel": 732.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 732.60003662109375, "distance_right": 3.5434957598378926e-07, "index_right": 346, "nodeid": "1386541.181931_5859198.062338", "id": "1386541.181931_5859198.062338", "name": "manhole_339_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386541.181931287748739, 5859198.062337793409824 ] } }, -{ "type": "Feature", "properties": { "_index": 345, "bedlevel": 729.60003662109375, "branchid": "pipe_9_E1222;pipe_9_E1223", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_340_generated", "shape": null, "area": 0.64, "streetlevel": 732.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 732.60003662109375, "distance_right": 4.1298571283569886e-07, "index_right": 347, "nodeid": "1386495.431539_5859218.233454", "id": "1386495.431539_5859218.233454", "name": "manhole_340_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386495.431538854492828, 5859218.233453613705933 ] } }, -{ "type": "Feature", "properties": { "_index": 346, "bedlevel": 739.5, "branchid": "pipe_9_E1223;pipe_9_E1224", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_341_generated", "shape": null, "area": 0.64, "streetlevel": 742.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 742.5, "distance_right": 6.042706584474631e-07, "index_right": 348, "nodeid": "1386449.681146_5859238.404569", "id": "1386449.681146_5859238.404569", "name": "manhole_341_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386449.681146421469748, 5859238.404569433070719 ] } }, -{ "type": "Feature", "properties": { "_index": 347, "bedlevel": 739.5, "branchid": "pipe_9_E1224;pipe_9_E1225", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_342_generated", "shape": null, "area": 0.64, "streetlevel": 742.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 742.5, "distance_right": 2.8591754721493927e-07, "index_right": 349, "nodeid": "1386404.749107_5859260.314222", "id": "1386404.749107_5859260.314222", "name": "manhole_342_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386404.749107032548636, 5859260.314221715554595 ] } }, -{ "type": "Feature", "properties": { "_index": 348, "bedlevel": 714.60003662109375, "branchid": "pipe_9_E1225;pipe_9_E1226", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_343_generated", "shape": null, "area": 0.64, "streetlevel": 717.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 717.60003662109375, "distance_right": 2.8677940449835489e-07, "index_right": 350, "nodeid": "1386360.756596_5859284.020065", "id": "1386360.756596_5859284.020065", "name": "manhole_343_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386360.756595908896998, 5859284.020064728334546 ] } }, -{ "type": "Feature", "properties": { "_index": 349, "bedlevel": 714.60003662109375, "branchid": "pipe_9_E1226;pipe_9_E1227", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_344_generated", "shape": null, "area": 0.64, "streetlevel": 717.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 717.60003662109375, "distance_right": 2.2879008155258781e-07, "index_right": 351, "nodeid": "1386317.622745_5859309.307279", "id": "1386317.622745_5859309.307279", "name": "manhole_344_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386317.622744857333601, 5859309.307279178872705 ] } }, -{ "type": "Feature", "properties": { "_index": 350, "bedlevel": 708.0, "branchid": "pipe_9_E1227;pipe_9_E1228", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_345_generated", "shape": null, "area": 0.64, "streetlevel": 711.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 711.0, "distance_right": 4.1844920248290768e-07, "index_right": 352, "nodeid": "1386274.488894_5859334.594494", "id": "1386274.488894_5859334.594494", "name": "manhole_345_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386274.488893805770203, 5859334.594493629410863 ] } }, -{ "type": "Feature", "properties": { "_index": 351, "bedlevel": 714.60003662109375, "branchid": "pipe_9_E1228;pipe_9_E1229", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_346_generated", "shape": null, "area": 0.64, "streetlevel": 717.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 717.60003662109375, "distance_right": 6.2631235412604143e-07, "index_right": 353, "nodeid": "1386231.354724_5859359.881164", "id": "1386231.354724_5859359.881164", "name": "manhole_346_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386231.354723542230204, 5859359.881163572892547 ] } }, -{ "type": "Feature", "properties": { "_index": 352, "bedlevel": 736.0, "branchid": "pipe_9_E1229;pipe_9_E1230", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_347_generated", "shape": null, "area": 0.64, "streetlevel": 739.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 739.0, "distance_right": 6.7422946470908165e-07, "index_right": 354, "nodeid": "1386188.788941_5859385.978958", "id": "1386188.788941_5859385.978958", "name": "manhole_347_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386188.788941488368437, 5859385.978958465158939 ] } }, -{ "type": "Feature", "properties": { "_index": 353, "bedlevel": 736.0, "branchid": "pipe_9_E1230;pipe_9_E1231", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_348_generated", "shape": null, "area": 0.64, "streetlevel": 739.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 739.0, "distance_right": 8.8043546398989323e-08, "index_right": 355, "nodeid": "1386153.170270_5859420.751349", "id": "1386153.170270_5859420.751349", "name": "manhole_348_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386153.170269979629666, 5859420.751348914578557 ] } }, -{ "type": "Feature", "properties": { "_index": 354, "bedlevel": 736.0, "branchid": "pipe_9_E1231;pipe_9_E1232", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_349_generated", "shape": null, "area": 0.64, "streetlevel": 739.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 739.0, "distance_right": 4.3670892571283769e-07, "index_right": 356, "nodeid": "1386127.241227_5859463.084468", "id": "1386127.241227_5859463.084468", "name": "manhole_349_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386127.241226618411019, 5859463.08446778729558 ] } }, -{ "type": "Feature", "properties": { "_index": 355, "bedlevel": 767.60003662109375, "branchid": "pipe_9_E1232;pipe_9_E1233", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_350_generated", "shape": null, "area": 0.64, "streetlevel": 770.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 770.60003662109375, "distance_right": 2.8822750408817674e-07, "index_right": 357, "nodeid": "1386108.996457_5859509.052054", "id": "1386108.996457_5859509.052054", "name": "manhole_350_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386108.996456971857697, 5859509.052053713239729 ] } }, -{ "type": "Feature", "properties": { "_index": 356, "bedlevel": 767.60003662109375, "branchid": "pipe_9_E1233;pipe_9_E1234", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_351_generated", "shape": null, "area": 0.64, "streetlevel": 770.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 770.60003662109375, "distance_right": 4.1608712174096055e-07, "index_right": 358, "nodeid": "1386105.954033_5859558.959127", "id": "1386105.954033_5859558.959127", "name": "manhole_351_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386105.954033384332433, 5859558.959127158857882 ] } }, -{ "type": "Feature", "properties": { "_index": 357, "bedlevel": 767.60003662109375, "branchid": "pipe_9_E1234;pipe_9_E1235", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_352_generated", "shape": null, "area": 0.64, "streetlevel": 770.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 770.60003662109375, "distance_right": 3.5779222205411915e-07, "index_right": 359, "nodeid": "1386101.917093_5859608.782216", "id": "1386101.917093_5859608.782216", "name": "manhole_352_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386101.917093347059563, 5859608.782215913757682 ] } }, -{ "type": "Feature", "properties": { "_index": 358, "bedlevel": 776.79998779296875, "branchid": "pipe_9_E1235;pipe_9_E1236", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_353_generated", "shape": null, "area": 0.64, "streetlevel": 779.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 779.79998779296875, "distance_right": 9.182652855228106e-08, "index_right": 360, "nodeid": "1386088.458339_5859656.652666", "id": "1386088.458339_5859656.652666", "name": "manhole_353_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386088.458339030388743, 5859656.652665913105011 ] } }, -{ "type": "Feature", "properties": { "_index": 359, "bedlevel": 776.79998779296875, "branchid": "pipe_9_E1236;pipe_9_E1237", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_354_generated", "shape": null, "area": 0.64, "streetlevel": 779.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 779.79998779296875, "distance_right": 4.3106410240470186e-07, "index_right": 361, "nodeid": "1386075.652030_5859704.419184", "id": "1386075.652030_5859704.419184", "name": "manhole_354_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386075.652030121767893, 5859704.419184413738549 ] } }, -{ "type": "Feature", "properties": { "_index": 360, "bedlevel": 776.79998779296875, "branchid": "pipe_9_E1237;pipe_9_E1238", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_355_generated", "shape": null, "area": 0.64, "streetlevel": 779.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 779.79998779296875, "distance_right": 5.9419274352607342e-07, "index_right": 362, "nodeid": "1386076.574771_5859754.410392", "id": "1386076.574771_5859754.410392", "name": "manhole_355_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386076.574770522769541, 5859754.410392354242504 ] } }, -{ "type": "Feature", "properties": { "_index": 361, "bedlevel": 777.79998779296875, "branchid": "pipe_9_E1238;pipe_9_E1239", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_356_generated", "shape": null, "area": 0.64, "streetlevel": 780.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 780.79998779296875, "distance_right": 3.0404508552976817e-07, "index_right": 363, "nodeid": "1386077.497511_5859804.401600", "id": "1386077.497511_5859804.401600", "name": "manhole_356_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386077.497510923538357, 5859804.401600294746459 ] } }, -{ "type": "Feature", "properties": { "_index": 362, "bedlevel": 777.79998779296875, "branchid": "pipe_9_E1239", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_357_generated", "shape": null, "area": 0.64, "streetlevel": 780.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 780.79998779296875, "distance_right": 4.0088765079104887e-07, "index_right": 364, "nodeid": "1386078.420251_5859854.392808", "id": "1386078.420251_5859854.392808", "name": "manhole_357_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386078.420251324307173, 5859854.392808235250413 ] } }, -{ "type": "Feature", "properties": { "_index": 363, "bedlevel": 811.29998779296875, "branchid": "pipe_10_E195", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_358_generated", "shape": null, "area": 0.64, "streetlevel": 814.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 814.29998779296875, "distance_right": 4.5480020130277707e-07, "index_right": 365, "nodeid": "1384050.267681_5856698.702002", "id": "1384050.267681_5856698.702002", "name": "manhole_358_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384050.267680946970358, 5856698.702001548372209 ] } }, -{ "type": "Feature", "properties": { "_index": 363, "bedlevel": 799.9000244140625, "branchid": "pipe_10_E195;pipe_10_E196", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_359_generated", "shape": null, "area": 0.64, "streetlevel": 802.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 802.9000244140625, "distance_right": 2.5012654807533162e-07, "index_right": 366, "nodeid": "1384085.778962_5856733.441067", "id": "1384085.778962_5856733.441067", "name": "manhole_359_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384085.778961833100766, 5856733.441067186184227 ] } }, -{ "type": "Feature", "properties": { "_index": 364, "bedlevel": 799.9000244140625, "branchid": "pipe_10_E196;pipe_10_E197", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_360_generated", "shape": null, "area": 0.64, "streetlevel": 802.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 802.9000244140625, "distance_right": 1.9869950468383852e-07, "index_right": 367, "nodeid": "1384122.993944_5856766.592180", "id": "1384122.993944_5856766.592180", "name": "manhole_360_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384122.993944165529683, 5856766.592179889790714 ] } }, -{ "type": "Feature", "properties": { "_index": 365, "bedlevel": 813.29998779296875, "branchid": "pipe_10_E197;pipe_10_E198", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_361_generated", "shape": null, "area": 0.64, "streetlevel": 816.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 816.29998779296875, "distance_right": 3.0801021440480768e-07, "index_right": 368, "nodeid": "1384160.350960_5856799.578122", "id": "1384160.350960_5856799.578122", "name": "manhole_361_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384160.350959801580757, 5856799.578122235834599 ] } }, -{ "type": "Feature", "properties": { "_index": 366, "bedlevel": 797.79998779296875, "branchid": "pipe_10_E198;pipe_10_E199", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_362_generated", "shape": null, "area": 0.64, "streetlevel": 800.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 800.79998779296875, "distance_right": 3.667194985852315e-07, "index_right": 369, "nodeid": "1384198.384374_5856831.724873", "id": "1384198.384374_5856831.724873", "name": "manhole_362_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384198.384374253917485, 5856831.724873264320195 ] } }, -{ "type": "Feature", "properties": { "_index": 367, "bedlevel": 797.79998779296875, "branchid": "pipe_10_E199;pipe_10_E200", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_363_generated", "shape": null, "area": 0.64, "streetlevel": 800.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 800.79998779296875, "distance_right": 4.676575474857736e-07, "index_right": 370, "nodeid": "1384230.112839_5856870.159957", "id": "1384230.112839_5856870.159957", "name": "manhole_363_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384230.112839305773377, 5856870.159957353956997 ] } }, -{ "type": "Feature", "properties": { "_index": 368, "bedlevel": 790.9000244140625, "branchid": "pipe_10_E200;pipe_10_E201", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_364_generated", "shape": null, "area": 0.64, "streetlevel": 793.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 793.9000244140625, "distance_right": 3.989035851645309e-07, "index_right": 371, "nodeid": "1384259.121702_5856910.628997", "id": "1384259.121702_5856910.628997", "name": "manhole_364_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384259.121702386764809, 5856910.628996902145445 ] } }, -{ "type": "Feature", "properties": { "_index": 369, "bedlevel": 804.60003662109375, "branchid": "pipe_10_E201;pipe_10_E202", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_365_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 4.0937169419879659e-07, "index_right": 372, "nodeid": "1384287.023719_5856951.925833", "id": "1384287.023719_5856951.925833", "name": "manhole_365_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384287.023718592710793, 5856951.925833041779697 ] } }, -{ "type": "Feature", "properties": { "_index": 370, "bedlevel": 804.60003662109375, "branchid": "pipe_10_E202;pipe_10_E203", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_366_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 5.4900122883217553e-07, "index_right": 373, "nodeid": "1384314.929269_5856993.220281", "id": "1384314.929269_5856993.220281", "name": "manhole_366_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384314.929269487503916, 5856993.22028074786067 ] } }, -{ "type": "Feature", "properties": { "_index": 371, "bedlevel": 804.60003662109375, "branchid": "pipe_10_E203;pipe_10_E204", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_367_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 4.4153137935343798e-07, "index_right": 374, "nodeid": "1384344.819753_5857033.056209", "id": "1384344.819753_5857033.056209", "name": "manhole_367_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384344.819752591196448, 5857033.056208833120763 ] } }, -{ "type": "Feature", "properties": { "_index": 372, "bedlevel": 804.60003662109375, "branchid": "pipe_10_E204;pipe_10_E205", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_368_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 5.2277323961967174e-07, "index_right": 375, "nodeid": "1384375.891110_5857072.024426", "id": "1384375.891110_5857072.024426", "name": "manhole_368_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384375.891110281459987, 5857072.024425559677184 ] } }, -{ "type": "Feature", "properties": { "_index": 373, "bedlevel": 804.60003662109375, "branchid": "pipe_10_E205;pipe_10_E206", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_369_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 3.2330989267580892e-07, "index_right": 376, "nodeid": "1384412.732156_5857105.507668", "id": "1384412.732156_5857105.507668", "name": "manhole_369_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384412.732155854580924, 5857105.507668288424611 ] } }, -{ "type": "Feature", "properties": { "_index": 374, "bedlevel": 792.9000244140625, "branchid": "pipe_10_E206;pipe_10_E207", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_370_generated", "shape": null, "area": 0.64, "streetlevel": 795.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 795.9000244140625, "distance_right": 5.2820652785107969e-07, "index_right": 377, "nodeid": "1384450.079483_5857138.509612", "id": "1384450.079483_5857138.509612", "name": "manhole_370_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384450.07948348694481, 5857138.509612204506993 ] } }, -{ "type": "Feature", "properties": { "_index": 375, "bedlevel": 792.9000244140625, "branchid": "pipe_10_E207;pipe_10_E208", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_371_generated", "shape": null, "area": 0.64, "streetlevel": 795.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 795.9000244140625, "distance_right": 3.553435013241558e-07, "index_right": 378, "nodeid": "1384487.426863_5857171.511497", "id": "1384487.426863_5857171.511497", "name": "manhole_371_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384487.42686335532926, 5857171.511497005820274 ] } }, -{ "type": "Feature", "properties": { "_index": 376, "bedlevel": 802.0, "branchid": "pipe_10_E208;pipe_10_E209", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_372_generated", "shape": null, "area": 0.64, "streetlevel": 805.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 805.0, "distance_right": 3.8657915864597202e-07, "index_right": 379, "nodeid": "1384525.207760_5857204.014278", "id": "1384525.207760_5857204.014278", "name": "manhole_372_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384525.207759798038751, 5857204.014277670532465 ] } }, -{ "type": "Feature", "properties": { "_index": 377, "bedlevel": 793.29998779296875, "branchid": "pipe_10_E209;pipe_10_E210", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_373_generated", "shape": null, "area": 0.64, "streetlevel": 796.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 796.29998779296875, "distance_right": 4.2528319184092202e-07, "index_right": 380, "nodeid": "1384563.111989_5857236.375066", "id": "1384563.111989_5857236.375066", "name": "manhole_373_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384563.111988977529109, 5857236.375065575353801 ] } }, -{ "type": "Feature", "properties": { "_index": 378, "bedlevel": 793.29998779296875, "branchid": "pipe_10_E210;pipe_10_E211", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_374_generated", "shape": null, "area": 0.64, "streetlevel": 796.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 796.29998779296875, "distance_right": 5.0546374469285607e-07, "index_right": 381, "nodeid": "1384601.016218_5857268.735853", "id": "1384601.016218_5857268.735853", "name": "manhole_374_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384601.016218156786636, 5857268.735853480175138 ] } }, -{ "type": "Feature", "properties": { "_index": 379, "bedlevel": 783.10003662109375, "branchid": "pipe_10_E211;pipe_10_E212", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_375_generated", "shape": null, "area": 0.64, "streetlevel": 786.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 786.10003662109375, "distance_right": 5.1070928007990266e-07, "index_right": 382, "nodeid": "1384638.920447_5857301.096641", "id": "1384638.920447_5857301.096641", "name": "manhole_375_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384638.920447336044163, 5857301.096641384996474 ] } }, -{ "type": "Feature", "properties": { "_index": 380, "bedlevel": 791.29998779296875, "branchid": "pipe_10_E212;pipe_10_E213", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_376_generated", "shape": null, "area": 0.64, "streetlevel": 794.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 794.29998779296875, "distance_right": 2.7491413546788394e-07, "index_right": 383, "nodeid": "1384669.604955_5857340.313405", "id": "1384669.604955_5857340.313405", "name": "manhole_376_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384669.604954990325496, 5857340.313404724933207 ] } }, -{ "type": "Feature", "properties": { "_index": 381, "bedlevel": 791.29998779296875, "branchid": "pipe_10_E213;pipe_10_E214", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_377_generated", "shape": null, "area": 0.64, "streetlevel": 794.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 794.29998779296875, "distance_right": 3.0550370542163772e-07, "index_right": 384, "nodeid": "1384699.518248_5857380.104403", "id": "1384699.518248_5857380.104403", "name": "manhole_377_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384699.518247769214213, 5857380.104403200559318 ] } }, -{ "type": "Feature", "properties": { "_index": 382, "bedlevel": 791.29998779296875, "branchid": "pipe_10_E214;pipe_10_E215", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_378_generated", "shape": null, "area": 0.64, "streetlevel": 794.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 794.29998779296875, "distance_right": 4.6591738879886883e-07, "index_right": 385, "nodeid": "1384719.806332_5857425.627417", "id": "1384719.806332_5857425.627417", "name": "manhole_378_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384719.806332413339987, 5857425.627417215146124 ] } }, -{ "type": "Feature", "properties": { "_index": 383, "bedlevel": 779.0, "branchid": "pipe_10_E215;pipe_10_E216", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_379_generated", "shape": null, "area": 0.64, "streetlevel": 782.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 782.0, "distance_right": 2.3711637815636632e-07, "index_right": 386, "nodeid": "1384740.094417_5857471.150431", "id": "1384740.094417_5857471.150431", "name": "manhole_379_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384740.094417057465762, 5857471.150431229732931 ] } }, -{ "type": "Feature", "properties": { "_index": 384, "bedlevel": 786.70001220703125, "branchid": "pipe_10_E216;pipe_10_E217", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_380_generated", "shape": null, "area": 0.64, "streetlevel": 789.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 789.70001220703125, "distance_right": 3.8553183229025237e-07, "index_right": 387, "nodeid": "1384760.382502_5857516.673445", "id": "1384760.382502_5857516.673445", "name": "manhole_380_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384760.382501701591536, 5857516.673445244319737 ] } }, -{ "type": "Feature", "properties": { "_index": 385, "bedlevel": 786.70001220703125, "branchid": "pipe_10_E217;pipe_10_E218", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_381_generated", "shape": null, "area": 0.64, "streetlevel": 789.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 789.70001220703125, "distance_right": 4.319475330982492e-07, "index_right": 388, "nodeid": "1384780.670586_5857562.196459", "id": "1384780.670586_5857562.196459", "name": "manhole_381_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384780.670586345717311, 5857562.196459258906543 ] } }, -{ "type": "Feature", "properties": { "_index": 386, "bedlevel": 793.5, "branchid": "pipe_10_E218;pipe_10_E219", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_382_generated", "shape": null, "area": 0.64, "streetlevel": 796.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 796.5, "distance_right": 4.9625998791457793e-07, "index_right": 389, "nodeid": "1384802.672203_5857606.838341", "id": "1384802.672203_5857606.838341", "name": "manhole_382_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384802.672203443944454, 5857606.838341221213341 ] } }, -{ "type": "Feature", "properties": { "_index": 387, "bedlevel": 768.9000244140625, "branchid": "pipe_10_E219;pipe_10_E220", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_383_generated", "shape": null, "area": 0.64, "streetlevel": 771.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 771.9000244140625, "distance_right": 2.8229532162483524e-07, "index_right": 390, "nodeid": "1384827.896526_5857649.823045", "id": "1384827.896526_5857649.823045", "name": "manhole_383_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384827.896526007680222, 5857649.823044718243182 ] } }, -{ "type": "Feature", "properties": { "_index": 388, "bedlevel": 768.9000244140625, "branchid": "pipe_10_E220;pipe_10_E221", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_384_generated", "shape": null, "area": 0.64, "streetlevel": 771.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 771.9000244140625, "distance_right": 2.0692567208455349e-07, "index_right": 391, "nodeid": "1384854.757883_5857691.606821", "id": "1384854.757883_5857691.606821", "name": "manhole_384_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384854.757882944308221, 5857691.606820800341666 ] } }, -{ "type": "Feature", "properties": { "_index": 389, "bedlevel": 768.9000244140625, "branchid": "pipe_10_E221;pipe_10_E222", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_385_generated", "shape": null, "area": 0.64, "streetlevel": 771.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 771.9000244140625, "distance_right": 1.9931880625148583e-07, "index_right": 392, "nodeid": "1384888.185769_5857728.573395", "id": "1384888.185769_5857728.573395", "name": "manhole_385_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384888.185768931638449, 5857728.573395187035203 ] } }, -{ "type": "Feature", "properties": { "_index": 390, "bedlevel": 754.9000244140625, "branchid": "pipe_10_E222;pipe_10_E223", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_386_generated", "shape": null, "area": 0.64, "streetlevel": 757.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 757.9000244140625, "distance_right": 4.3330183135741007e-07, "index_right": 393, "nodeid": "1384921.613655_5857765.539970", "id": "1384921.613655_5857765.539970", "name": "manhole_386_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384921.613654918735847, 5857765.539969574660063 ] } }, -{ "type": "Feature", "properties": { "_index": 391, "bedlevel": 754.9000244140625, "branchid": "pipe_10_E223;pipe_10_E224", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_387_generated", "shape": null, "area": 0.64, "streetlevel": 757.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 757.9000244140625, "distance_right": 3.5666888496789524e-07, "index_right": 394, "nodeid": "1384956.145454_5857801.445757", "id": "1384956.145454_5857801.445757", "name": "manhole_387_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384956.145453942706808, 5857801.445756647735834 ] } }, -{ "type": "Feature", "properties": { "_index": 392, "bedlevel": 754.9000244140625, "branchid": "pipe_10_E224;pipe_10_E225", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_388_generated", "shape": null, "area": 0.64, "streetlevel": 757.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 757.9000244140625, "distance_right": 5.9257077545387882e-07, "index_right": 395, "nodeid": "1384991.751307_5857836.319449", "id": "1384991.751307_5857836.319449", "name": "manhole_388_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384991.751306539867073, 5857836.319449373520911 ] } }, -{ "type": "Feature", "properties": { "_index": 393, "bedlevel": 743.0, "branchid": "pipe_10_E225;pipe_10_E226", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_389_generated", "shape": null, "area": 0.64, "streetlevel": 746.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 746.0, "distance_right": 1.6952005672566127e-07, "index_right": 396, "nodeid": "1385027.357159_5857871.193142", "id": "1385027.357159_5857871.193142", "name": "manhole_389_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385027.357159137027338, 5857871.193142099305987 ] } }, -{ "type": "Feature", "properties": { "_index": 394, "bedlevel": 752.79998779296875, "branchid": "pipe_10_E226;pipe_10_E227", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_390_generated", "shape": null, "area": 0.64, "streetlevel": 755.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 755.79998779296875, "distance_right": 3.183628517451925e-07, "index_right": 397, "nodeid": "1385062.963012_5857906.066835", "id": "1385062.963012_5857906.066835", "name": "manhole_390_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385062.963011734187603, 5857906.066834825091064 ] } }, -{ "type": "Feature", "properties": { "_index": 395, "bedlevel": 725.60003662109375, "branchid": "pipe_10_E227;pipe_10_E228", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_391_generated", "shape": null, "area": 0.64, "streetlevel": 728.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 728.60003662109375, "distance_right": 5.5717618408289852e-07, "index_right": 398, "nodeid": "1385098.568864_5857940.940528", "id": "1385098.568864_5857940.940528", "name": "manhole_391_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385098.568864331347868, 5857940.940527551807463 ] } }, -{ "type": "Feature", "properties": { "_index": 396, "bedlevel": 725.60003662109375, "branchid": "pipe_10_E228;pipe_10_E229", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_392_generated", "shape": null, "area": 0.64, "streetlevel": 728.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 728.60003662109375, "distance_right": 4.1749358665480613e-07, "index_right": 399, "nodeid": "1385135.753846_5857974.029479", "id": "1385135.753846_5857974.029479", "name": "manhole_392_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385135.753846400883049, 5857974.029479116201401 ] } }, -{ "type": "Feature", "properties": { "_index": 397, "bedlevel": 725.60003662109375, "branchid": "pipe_10_E229;pipe_10_E230", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_393_generated", "shape": null, "area": 0.64, "streetlevel": 728.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 728.60003662109375, "distance_right": 2.2747351319038044e-07, "index_right": 400, "nodeid": "1385175.738456_5858003.622976", "id": "1385175.738456_5858003.622976", "name": "manhole_393_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385175.738456205930561, 5858003.622975903563201 ] } }, -{ "type": "Feature", "properties": { "_index": 398, "bedlevel": 732.60003662109375, "branchid": "pipe_10_E230;pipe_10_E231", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_394_generated", "shape": null, "area": 0.64, "streetlevel": 735.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 735.60003662109375, "distance_right": 3.566935824899918e-07, "index_right": 401, "nodeid": "1385218.653757_5858028.965197", "id": "1385218.653757_5858028.965197", "name": "manhole_394_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385218.653756857383996, 5858028.965196672827005 ] } }, -{ "type": "Feature", "properties": { "_index": 399, "bedlevel": 732.60003662109375, "branchid": "pipe_10_E231;pipe_10_E232", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_395_generated", "shape": null, "area": 0.64, "streetlevel": 735.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 735.60003662109375, "distance_right": 2.440171783151832e-07, "index_right": 402, "nodeid": "1385262.454937_5858052.706983", "id": "1385262.454937_5858052.706983", "name": "manhole_395_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385262.454936756985262, 5858052.706982978619635 ] } }, -{ "type": "Feature", "properties": { "_index": 400, "bedlevel": 739.0, "branchid": "pipe_10_E232;pipe_10_E233", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_396_generated", "shape": null, "area": 0.64, "streetlevel": 742.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 742.0, "distance_right": 3.1389025035042856e-07, "index_right": 403, "nodeid": "1385306.715555_5858075.618745", "id": "1385306.715555_5858075.618745", "name": "manhole_396_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385306.715555034345016, 5858075.618745312094688 ] } }, -{ "type": "Feature", "properties": { "_index": 401, "bedlevel": 739.0, "branchid": "pipe_10_E233;pipe_10_E234", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_397_generated", "shape": null, "area": 0.64, "streetlevel": 742.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 742.0, "distance_right": 4.7303629503344029e-07, "index_right": 404, "nodeid": "1385350.976173_5858098.530508", "id": "1385350.976173_5858098.530508", "name": "manhole_397_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385350.97617331170477, 5858098.530507644638419 ] } }, -{ "type": "Feature", "properties": { "_index": 402, "bedlevel": 733.0, "branchid": "pipe_10_E234;pipe_10_E235", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_398_generated", "shape": null, "area": 0.64, "streetlevel": 736.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 736.0, "distance_right": 4.1132101639328379e-07, "index_right": 405, "nodeid": "1385395.236792_5858121.442270", "id": "1385395.236792_5858121.442270", "name": "manhole_398_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385395.236791589297354, 5858121.442269978113472 ] } }, -{ "type": "Feature", "properties": { "_index": 403, "bedlevel": 733.0, "branchid": "pipe_10_E235;pipe_10_E236", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_399_generated", "shape": null, "area": 0.64, "streetlevel": 736.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 736.0, "distance_right": 3.3846440994221831e-07, "index_right": 406, "nodeid": "1385439.497410_5858144.354032", "id": "1385439.497410_5858144.354032", "name": "manhole_399_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385439.497409866657108, 5858144.354032310657203 ] } }, -{ "type": "Feature", "properties": { "_index": 404, "bedlevel": 734.9000244140625, "branchid": "pipe_10_E236;pipe_10_E237", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_400_generated", "shape": null, "area": 0.64, "streetlevel": 737.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 737.9000244140625, "distance_right": 3.8384905064986902e-07, "index_right": 407, "nodeid": "1385483.758028_5858167.265795", "id": "1385483.758028_5858167.265795", "name": "manhole_400_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385483.758028144016862, 5858167.265794644132257 ] } }, -{ "type": "Feature", "properties": { "_index": 405, "bedlevel": 734.9000244140625, "branchid": "pipe_10_E237;pipe_10_E238", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_401_generated", "shape": null, "area": 0.64, "streetlevel": 737.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 737.9000244140625, "distance_right": 4.2201580210351053e-07, "index_right": 408, "nodeid": "1385528.018646_5858190.177557", "id": "1385528.018646_5858190.177557", "name": "manhole_401_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385528.018646421376616, 5858190.17755697760731 ] } }, -{ "type": "Feature", "properties": { "_index": 406, "bedlevel": 724.29998779296875, "branchid": "pipe_10_E238;pipe_10_E239", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_402_generated", "shape": null, "area": 0.64, "streetlevel": 727.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 727.29998779296875, "distance_right": 3.5470585152500708e-07, "index_right": 409, "nodeid": "1385571.606102_5858214.277655", "id": "1385571.606102_5858214.277655", "name": "manhole_402_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385571.606102279853076, 5858214.277655217796564 ] } }, -{ "type": "Feature", "properties": { "_index": 407, "bedlevel": 724.29998779296875, "branchid": "pipe_10_E239;pipe_10_E240", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_403_generated", "shape": null, "area": 0.64, "streetlevel": 727.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 727.29998779296875, "distance_right": 1.7555615806898356e-07, "index_right": 410, "nodeid": "1385614.013401_5858240.461089", "id": "1385614.013401_5858240.461089", "name": "manhole_403_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385614.013400863157585, 5858240.461089110001922 ] } }, -{ "type": "Feature", "properties": { "_index": 408, "bedlevel": 687.60003662109375, "branchid": "pipe_10_E240;pipe_10_E241", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_404_generated", "shape": null, "area": 0.64, "streetlevel": 690.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 690.60003662109375, "distance_right": 4.4657305906836809e-07, "index_right": 411, "nodeid": "1385656.420699_5858266.644523", "id": "1385656.420699_5858266.644523", "name": "manhole_404_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385656.420699446462095, 5858266.644523002207279 ] } }, -{ "type": "Feature", "properties": { "_index": 409, "bedlevel": 730.60003662109375, "branchid": "pipe_10_E241;pipe_10_E242", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_405_generated", "shape": null, "area": 0.64, "streetlevel": 733.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 733.60003662109375, "distance_right": 4.9396989618903532e-07, "index_right": 412, "nodeid": "1385698.773112_5858292.896190", "id": "1385698.773112_5858292.896190", "name": "manhole_405_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385698.773111530812457, 5858292.8961898451671 ] } }, -{ "type": "Feature", "properties": { "_index": 410, "bedlevel": 730.60003662109375, "branchid": "pipe_10_E242;pipe_10_E243", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_406_generated", "shape": null, "area": 0.64, "streetlevel": 733.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 733.60003662109375, "distance_right": 5.9111518677801371e-07, "index_right": 413, "nodeid": "1385733.435650_5858328.707635", "id": "1385733.435650_5858328.707635", "name": "manhole_406_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385733.435650466475636, 5858328.707634637132287 ] } }, -{ "type": "Feature", "properties": { "_index": 411, "bedlevel": 718.60003662109375, "branchid": "pipe_10_E243;pipe_10_E244", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_407_generated", "shape": null, "area": 0.64, "streetlevel": 721.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 721.60003662109375, "distance_right": 5.8739235381329021e-07, "index_right": 414, "nodeid": "1385768.098189_5858364.519079", "id": "1385768.098189_5858364.519079", "name": "manhole_407_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385768.098189401905984, 5858364.519079428166151 ] } }, -{ "type": "Feature", "properties": { "_index": 412, "bedlevel": 718.60003662109375, "branchid": "pipe_10_E244;pipe_10_E245", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_408_generated", "shape": null, "area": 0.64, "streetlevel": 721.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 721.60003662109375, "distance_right": 3.8476255406641031e-07, "index_right": 415, "nodeid": "1385795.882535_5858405.467094", "id": "1385795.882535_5858405.467094", "name": "manhole_408_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385795.882535298354924, 5858405.467093757353723 ] } }, -{ "type": "Feature", "properties": { "_index": 413, "bedlevel": 736.0, "branchid": "pipe_10_E245;pipe_10_E246", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_409_generated", "shape": null, "area": 0.64, "streetlevel": 739.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 739.0, "distance_right": 3.3645639254133238e-07, "index_right": 416, "nodeid": "1385820.377635_5858448.871486", "id": "1385820.377635_5858448.871486", "name": "manhole_409_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385820.377634756267071, 5858448.871486231684685 ] } }, -{ "type": "Feature", "properties": { "_index": 414, "bedlevel": 724.79998779296875, "branchid": "pipe_10_E246;pipe_10_E247", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_410_generated", "shape": null, "area": 0.64, "streetlevel": 727.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 727.79998779296875, "distance_right": 3.9048475593888301e-07, "index_right": 417, "nodeid": "1385841.084314_5858493.920932", "id": "1385841.084314_5858493.920932", "name": "manhole_410_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385841.084314390551299, 5858493.920932004228234 ] } }, -{ "type": "Feature", "properties": { "_index": 415, "bedlevel": 724.79998779296875, "branchid": "pipe_10_E247;pipe_10_E248", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_411_generated", "shape": null, "area": 0.64, "streetlevel": 727.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 727.79998779296875, "distance_right": 4.1240584132304262e-07, "index_right": 418, "nodeid": "1385856.076262_5858541.451898", "id": "1385856.076262_5858541.451898", "name": "manhole_411_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385856.076261736918241, 5858541.451897682622075 ] } }, -{ "type": "Feature", "properties": { "_index": 416, "bedlevel": 731.9000244140625, "branchid": "pipe_10_E248;pipe_10_E249", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_412_generated", "shape": null, "area": 0.64, "streetlevel": 734.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 734.9000244140625, "distance_right": 3.9323655141917895e-07, "index_right": 419, "nodeid": "1385865.668900_5858590.250007", "id": "1385865.668900_5858590.250007", "name": "manhole_412_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385865.668899663724005, 5858590.250006795860827 ] } }, -{ "type": "Feature", "properties": { "_index": 417, "bedlevel": 731.9000244140625, "branchid": "pipe_10_E249;pipe_10_E250", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_413_generated", "shape": null, "area": 0.64, "streetlevel": 734.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 734.9000244140625, "distance_right": 4.9549867528789424e-07, "index_right": 420, "nodeid": "1385873.387287_5858639.487977", "id": "1385873.387287_5858639.487977", "name": "manhole_413_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385873.387286560609937, 5858639.487976770848036 ] } }, -{ "type": "Feature", "properties": { "_index": 418, "bedlevel": 748.4000244140625, "branchid": "pipe_10_E250;pipe_10_E251", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_414_generated", "shape": null, "area": 0.64, "streetlevel": 751.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 751.4000244140625, "distance_right": 2.5224403860867615e-07, "index_right": 421, "nodeid": "1385875.017950_5858689.287253", "id": "1385875.017950_5858689.287253", "name": "manhole_414_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385875.017949819331989, 5858689.287253175862134 ] } }, -{ "type": "Feature", "properties": { "_index": 419, "bedlevel": 748.4000244140625, "branchid": "pipe_10_E251;pipe_10_E252", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_415_generated", "shape": null, "area": 0.64, "streetlevel": 751.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 751.4000244140625, "distance_right": 5.6460120498363627e-07, "index_right": 422, "nodeid": "1385876.432929_5858739.106416", "id": "1385876.432929_5858739.106416", "name": "manhole_415_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385876.432928551919758, 5858739.106416343711317 ] } }, -{ "type": "Feature", "properties": { "_index": 420, "bedlevel": 748.4000244140625, "branchid": "pipe_10_E252;pipe_10_E253", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_416_generated", "shape": null, "area": 0.64, "streetlevel": 751.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 751.4000244140625, "distance_right": 4.8251054346948512e-07, "index_right": 423, "nodeid": "1385878.329822_5858788.908142", "id": "1385878.329822_5858788.908142", "name": "manhole_416_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385878.329821793129668, 5858788.908141564577818 ] } }, -{ "type": "Feature", "properties": { "_index": 421, "bedlevel": 756.70001220703125, "branchid": "pipe_10_E253;pipe_10_E254", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_417_generated", "shape": null, "area": 0.64, "streetlevel": 759.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 759.70001220703125, "distance_right": 2.4793227757235602e-07, "index_right": 424, "nodeid": "1385880.519215_5858838.699283", "id": "1385880.519215_5858838.699283", "name": "manhole_417_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385880.51921496167779, 5858838.69928275514394 ] } }, -{ "type": "Feature", "properties": { "_index": 422, "bedlevel": 756.70001220703125, "branchid": "pipe_10_E254;pipe_10_E255", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_418_generated", "shape": null, "area": 0.64, "streetlevel": 759.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 759.70001220703125, "distance_right": 4.9687526799931372e-07, "index_right": 425, "nodeid": "1385882.620351_5858888.493530", "id": "1385882.620351_5858888.493530", "name": "manhole_418_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385882.620351102668792, 5858888.493530485779047 ] } }, -{ "type": "Feature", "properties": { "_index": 423, "bedlevel": 756.70001220703125, "branchid": "pipe_10_E255;pipe_10_E256", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_419_generated", "shape": null, "area": 0.64, "streetlevel": 759.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 759.70001220703125, "distance_right": 4.8876958658520276e-07, "index_right": 426, "nodeid": "1385883.937444_5858938.315378", "id": "1385883.937444_5858938.315378", "name": "manhole_419_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385883.937443709466606, 5858938.315377607010305 ] } }, -{ "type": "Feature", "properties": { "_index": 424, "bedlevel": 763.10003662109375, "branchid": "pipe_10_E256;pipe_10_E257", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_420_generated", "shape": null, "area": 0.64, "streetlevel": 766.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 766.10003662109375, "distance_right": 5.5059992250426879e-07, "index_right": 427, "nodeid": "1385885.254539_5858988.137225", "id": "1385885.254539_5858988.137225", "name": "manhole_420_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385885.254538560518995, 5858988.137224668636918 ] } }, -{ "type": "Feature", "properties": { "_index": 425, "bedlevel": 763.10003662109375, "branchid": "pipe_10_E257;pipe_10_E258", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_421_generated", "shape": null, "area": 0.64, "streetlevel": 766.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 766.10003662109375, "distance_right": 4.3659669481212074e-07, "index_right": 428, "nodeid": "1385890.650534_5859037.630401", "id": "1385890.650534_5859037.630401", "name": "manhole_421_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385890.650534195825458, 5859037.630400610156357 ] } }, -{ "type": "Feature", "properties": { "_index": 426, "bedlevel": 763.10003662109375, "branchid": "pipe_10_E258;pipe_10_E259", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_422_generated", "shape": null, "area": 0.64, "streetlevel": 766.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 766.10003662109375, "distance_right": 1.9950746892356647e-07, "index_right": 429, "nodeid": "1385901.777443_5859086.092394", "id": "1385901.777443_5859086.092394", "name": "manhole_422_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385901.777442803606391, 5859086.09239396546036 ] } }, -{ "type": "Feature", "properties": { "_index": 427, "bedlevel": 765.60003662109375, "branchid": "pipe_10_E259;pipe_10_E260", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_423_generated", "shape": null, "area": 0.64, "streetlevel": 768.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 768.60003662109375, "distance_right": 4.4190839080191394e-07, "index_right": 430, "nodeid": "1385915.397955_5859134.034368", "id": "1385915.397955_5859134.034368", "name": "manhole_423_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385915.397954803425819, 5859134.03436760418117 ] } }, -{ "type": "Feature", "properties": { "_index": 428, "bedlevel": 759.79998779296875, "branchid": "pipe_10_E260;pipe_10_E261", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_424_generated", "shape": null, "area": 0.64, "streetlevel": 762.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.79998779296875, "distance_right": 4.988545283431086e-07, "index_right": 431, "nodeid": "1385928.426053_5859182.139209", "id": "1385928.426053_5859182.139209", "name": "manhole_424_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385928.42605347908102, 5859182.139209139160812 ] } }, -{ "type": "Feature", "properties": { "_index": 429, "bedlevel": 759.5, "branchid": "pipe_10_E261;pipe_10_E262", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_425_generated", "shape": null, "area": 0.64, "streetlevel": 762.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.5, "distance_right": 5.2005172650962332e-07, "index_right": 432, "nodeid": "1385941.228082_5859230.306202", "id": "1385941.228082_5859230.306202", "name": "manhole_425_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385941.228082312969491, 5859230.306202415376902 ] } }, -{ "type": "Feature", "properties": { "_index": 430, "bedlevel": 759.5, "branchid": "pipe_10_E262;pipe_10_E263", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_426_generated", "shape": null, "area": 0.64, "streetlevel": 762.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.5, "distance_right": 2.8382466111334913e-07, "index_right": 433, "nodeid": "1385945.092689_5859279.734331", "id": "1385945.092689_5859279.734331", "name": "manhole_426_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385945.092689140234143, 5859279.734331246465445 ] } }, -{ "type": "Feature", "properties": { "_index": 431, "bedlevel": 759.5, "branchid": "pipe_10_E263;pipe_10_E264", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_427_generated", "shape": null, "area": 0.64, "streetlevel": 762.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.5, "distance_right": 4.5600920280355245e-07, "index_right": 434, "nodeid": "1385937.902412_5859328.779896", "id": "1385937.902412_5859328.779896", "name": "manhole_427_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385937.902412303024903, 5859328.779896341264248 ] } }, -{ "type": "Feature", "properties": { "_index": 432, "bedlevel": 775.0, "branchid": "pipe_10_E264;pipe_10_E265", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_428_generated", "shape": null, "area": 0.64, "streetlevel": 778.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 778.0, "distance_right": 3.5119784074524645e-07, "index_right": 435, "nodeid": "1385932.795076_5859378.173214", "id": "1385932.795076_5859378.173214", "name": "manhole_428_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385932.795075723901391, 5859378.173214216716588 ] } }, -{ "type": "Feature", "properties": { "_index": 433, "bedlevel": 775.0, "branchid": "pipe_10_E265;pipe_10_E266", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_429_generated", "shape": null, "area": 0.64, "streetlevel": 778.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 778.0, "distance_right": 4.695879513954162e-07, "index_right": 436, "nodeid": "1385937.702696_5859427.770255", "id": "1385937.702696_5859427.770255", "name": "manhole_429_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385937.702695531537756, 5859427.770254967734218 ] } }, -{ "type": "Feature", "properties": { "_index": 434, "bedlevel": 775.0, "branchid": "pipe_10_E266;pipe_10_E267", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_430_generated", "shape": null, "area": 0.64, "streetlevel": 778.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 778.0, "distance_right": 1.8520459362715071e-07, "index_right": 437, "nodeid": "1385939.035938_5859477.502304", "id": "1385939.035938_5859477.502304", "name": "manhole_430_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385939.035937832202762, 5859477.50230407807976 ] } }, -{ "type": "Feature", "properties": { "_index": 435, "bedlevel": 792.9000244140625, "branchid": "pipe_10_E267;pipe_10_E268", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_431_generated", "shape": null, "area": 0.64, "streetlevel": 795.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 795.9000244140625, "distance_right": 2.5355941251856743e-07, "index_right": 438, "nodeid": "1385937.883638_5859527.328235", "id": "1385937.883638_5859527.328235", "name": "manhole_431_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385937.883638251805678, 5859527.328234969638288 ] } }, -{ "type": "Feature", "properties": { "_index": 436, "bedlevel": 792.9000244140625, "branchid": "pipe_10_E268;pipe_10_E269", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_432_generated", "shape": null, "area": 0.64, "streetlevel": 795.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 795.9000244140625, "distance_right": 3.6358463847525687e-07, "index_right": 439, "nodeid": "1385940.515994_5859576.989168", "id": "1385940.515994_5859576.989168", "name": "manhole_432_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385940.515994266141206, 5859576.989168248139322 ] } }, -{ "type": "Feature", "properties": { "_index": 437, "bedlevel": 792.9000244140625, "branchid": "pipe_10_E269;pipe_10_E270", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_433_generated", "shape": null, "area": 0.64, "streetlevel": 795.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 795.9000244140625, "distance_right": 4.9116737648064597e-07, "index_right": 440, "nodeid": "1385950.701545_5859625.530177", "id": "1385950.701545_5859625.530177", "name": "manhole_433_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385950.701545101590455, 5859625.530176519416273 ] } }, -{ "type": "Feature", "properties": { "_index": 438, "bedlevel": 812.0, "branchid": "pipe_10_E270;pipe_10_E271", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_434_generated", "shape": null, "area": 0.64, "streetlevel": 815.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 815.0, "distance_right": 5.5124507418760386e-07, "index_right": 441, "nodeid": "1385970.467743_5859670.991299", "id": "1385970.467743_5859670.991299", "name": "manhole_434_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385970.467743494315073, 5859670.991298755630851 ] } }, -{ "type": "Feature", "properties": { "_index": 439, "bedlevel": 812.0, "branchid": "pipe_10_E271;pipe_10_E272", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_435_generated", "shape": null, "area": 0.64, "streetlevel": 815.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 815.0, "distance_right": 2.2592636056373782e-07, "index_right": 442, "nodeid": "1386011.983088_5859697.862917", "id": "1386011.983088_5859697.862917", "name": "manhole_435_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386011.983088220236823, 5859697.862916950136423 ] } }, -{ "type": "Feature", "properties": { "_index": 440, "bedlevel": 776.79998779296875, "branchid": "pipe_10_E272;pipe_10_E273", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_436_generated", "shape": null, "area": 0.64, "streetlevel": 779.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 779.79998779296875, "distance_right": 2.826630180046859e-07, "index_right": 443, "nodeid": "1386052.213596_5859727.119808", "id": "1386052.213596_5859727.119808", "name": "manhole_436_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386052.213596233632416, 5859727.119808158837259 ] } }, -{ "type": "Feature", "properties": { "_index": 441, "bedlevel": 777.79998779296875, "branchid": "pipe_10_E273;pipe_10_E274", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_437_generated", "shape": null, "area": 0.64, "streetlevel": 780.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 780.79998779296875, "distance_right": 1.7247219687616297e-07, "index_right": 444, "nodeid": "1386046.501013_5859771.612672", "id": "1386046.501013_5859771.612672", "name": "manhole_437_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386046.501012831227854, 5859771.612671964801848 ] } }, -{ "type": "Feature", "properties": { "_index": 442, "bedlevel": 777.79998779296875, "branchid": "pipe_10_E274;pipe_10_E275", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_438_generated", "shape": null, "area": 0.64, "streetlevel": 780.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 780.79998779296875, "distance_right": 2.6156737925919828e-07, "index_right": 445, "nodeid": "1386026.809696_5859816.873920", "id": "1386026.809696_5859816.873920", "name": "manhole_438_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386026.809695787727833, 5859816.873920152895153 ] } }, -{ "type": "Feature", "properties": { "_index": 443, "bedlevel": 777.79998779296875, "branchid": "pipe_10_E275;pipe_10_E276", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_439_generated", "shape": null, "area": 0.64, "streetlevel": 780.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 780.79998779296875, "distance_right": 3.7655071668317508e-07, "index_right": 446, "nodeid": "1386030.149607_5859866.379010", "id": "1386030.149607_5859866.379010", "name": "manhole_439_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386030.149607364553958, 5859866.379009906202555 ] } }, -{ "type": "Feature", "properties": { "_index": 444, "bedlevel": 763.29998779296875, "branchid": "pipe_10_E276", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_440_generated", "shape": null, "area": 0.64, "streetlevel": 766.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 766.29998779296875, "distance_right": 3.8584702415109949e-07, "index_right": 447, "nodeid": "1386045.250939_5859913.859036", "id": "1386045.250939_5859913.859036", "name": "manhole_440_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386045.250939248362556, 5859913.859036295674741 ] } }, -{ "type": "Feature", "properties": { "_index": 445, "bedlevel": 797.79998779296875, "branchid": "pipe_11_E0", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_441_generated", "shape": null, "area": 0.64, "streetlevel": 800.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 800.79998779296875, "distance_right": 4.7301652606593837e-07, "index_right": 448, "nodeid": "1384196.861816_5856829.880484", "id": "1384196.861816_5856829.880484", "name": "manhole_441_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384196.861816460033879, 5856829.88048410974443 ] } }, -{ "type": "Feature", "properties": { "_index": 445, "bedlevel": 797.79998779296875, "branchid": "pipe_11_E0;pipe_11_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_442_generated", "shape": null, "area": 0.64, "streetlevel": 800.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 800.79998779296875, "distance_right": 4.1916041075255855e-07, "index_right": 449, "nodeid": "1384235.225193_5856854.977666", "id": "1384235.225193_5856854.977666", "name": "manhole_442_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384235.22519311751239, 5856854.977665597572923 ] } }, -{ "type": "Feature", "properties": { "_index": 446, "bedlevel": 790.9000244140625, "branchid": "pipe_11_E1;pipe_11_E2", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_443_generated", "shape": null, "area": 0.64, "streetlevel": 793.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 793.9000244140625, "distance_right": 1.8064117134611431e-07, "index_right": 450, "nodeid": "1384263.450330_5856892.038371", "id": "1384263.450330_5856892.038371", "name": "manhole_443_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384263.450329831801355, 5856892.038370934315026 ] } }, -{ "type": "Feature", "properties": { "_index": 447, "bedlevel": 790.9000244140625, "branchid": "pipe_11_E2;pipe_11_E3", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_444_generated", "shape": null, "area": 0.64, "streetlevel": 793.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 793.9000244140625, "distance_right": 5.2895601992239946e-07, "index_right": 451, "nodeid": "1384291.675467_5856929.099076", "id": "1384291.675467_5856929.099076", "name": "manhole_444_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384291.675466545857489, 5856929.099076271057129 ] } }, -{ "type": "Feature", "properties": { "_index": 448, "bedlevel": 804.60003662109375, "branchid": "pipe_11_E3;pipe_11_E4", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_445_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 4.6972328747941346e-07, "index_right": 452, "nodeid": "1384319.900603_5856966.159782", "id": "1384319.900603_5856966.159782", "name": "manhole_445_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384319.900603260146454, 5856966.159781608730555 ] } }, -{ "type": "Feature", "properties": { "_index": 449, "bedlevel": 804.60003662109375, "branchid": "pipe_11_E4;pipe_11_E5", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_446_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 3.2505859644673266e-07, "index_right": 453, "nodeid": "1384347.205868_5857003.894511", "id": "1384347.205868_5857003.894511", "name": "manhole_446_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384347.205867683747783, 5857003.894510924816132 ] } }, -{ "type": "Feature", "properties": { "_index": 450, "bedlevel": 796.0, "branchid": "pipe_11_E5;pipe_11_E6", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_447_generated", "shape": null, "area": 0.64, "streetlevel": 799.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 799.0, "distance_right": 4.0063787966893061e-08, "index_right": 454, "nodeid": "1384380.322691_5857036.360282", "id": "1384380.322691_5857036.360282", "name": "manhole_447_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384380.322691001230851, 5857036.360282040201128 ] } }, -{ "type": "Feature", "properties": { "_index": 451, "bedlevel": 804.60003662109375, "branchid": "pipe_11_E6;pipe_11_E7", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_448_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 6.5217326255448256e-07, "index_right": 455, "nodeid": "1384415.156611_5857067.291694", "id": "1384415.156611_5857067.291694", "name": "manhole_448_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384415.156610523350537, 5857067.291694445535541 ] } }, -{ "type": "Feature", "properties": { "_index": 452, "bedlevel": 792.9000244140625, "branchid": "pipe_11_E7;pipe_11_E8", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_449_generated", "shape": null, "area": 0.64, "streetlevel": 795.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 795.9000244140625, "distance_right": 2.5437427121489189e-07, "index_right": 456, "nodeid": "1384449.343576_5857098.828100", "id": "1384449.343576_5857098.828100", "name": "manhole_449_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384449.343575850594789, 5857098.828100205399096 ] } }, -{ "type": "Feature", "properties": { "_index": 453, "bedlevel": 792.9000244140625, "branchid": "pipe_11_E8;pipe_11_E9", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_450_generated", "shape": null, "area": 0.64, "streetlevel": 795.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 795.9000244140625, "distance_right": 2.5635753496972149e-07, "index_right": 457, "nodeid": "1384470.004810_5857139.926174", "id": "1384470.004810_5857139.926174", "name": "manhole_450_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384470.004810179118067, 5857139.926174183376133 ] } }, -{ "type": "Feature", "properties": { "_index": 454, "bedlevel": 792.9000244140625, "branchid": "pipe_11_E9", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_451_generated", "shape": null, "area": 0.64, "streetlevel": 795.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 795.9000244140625, "distance_right": 2.3880128290434959e-07, "index_right": 458, "nodeid": "1384484.180762_5857184.301805", "id": "1384484.180762_5857184.301805", "name": "manhole_451_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384484.18076178082265, 5857184.301805094815791 ] } }, -{ "type": "Feature", "properties": { "_index": 455, "bedlevel": 804.60003662109375, "branchid": "pipe_12_E0", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_452_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 2.9575907640532436e-07, "index_right": 459, "nodeid": "1384289.065524_5856954.947841", "id": "1384289.065524_5856954.947841", "name": "manhole_452_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384289.06552429520525, 5856954.947841017507017 ] } }, -{ "type": "Feature", "properties": { "_index": 455, "bedlevel": 804.60003662109375, "branchid": "pipe_12_E0;pipe_12_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_453_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 4.147576493632742e-07, "index_right": 460, "nodeid": "1384305.049611_5856994.887349", "id": "1384305.049611_5856994.887349", "name": "manhole_453_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384305.049610810354352, 5856994.88734863139689 ] } }, -{ "type": "Feature", "properties": { "_index": 456, "bedlevel": 804.60003662109375, "branchid": "pipe_12_E1;pipe_12_E2", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_454_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 4.0680171125278462e-07, "index_right": 461, "nodeid": "1384321.033697_5857034.826856", "id": "1384321.033697_5857034.826856", "name": "manhole_454_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384321.033697325503454, 5857034.82685624435544 ] } }, -{ "type": "Feature", "properties": { "_index": 457, "bedlevel": 796.0, "branchid": "pipe_12_E2;pipe_12_E3", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_455_generated", "shape": null, "area": 0.64, "streetlevel": 799.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 799.0, "distance_right": 5.1416054878534695e-07, "index_right": 462, "nodeid": "1384347.445656_5857068.672039", "id": "1384347.445656_5857068.672039", "name": "manhole_455_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384347.445656489115208, 5857068.672038841992617 ] } }, -{ "type": "Feature", "properties": { "_index": 458, "bedlevel": 804.60003662109375, "branchid": "pipe_12_E3;pipe_12_E4", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_456_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 6.3615944847267436e-07, "index_right": 463, "nodeid": "1384374.130628_5857102.406952", "id": "1384374.130628_5857102.406952", "name": "manhole_456_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384374.130628447979689, 5857102.406951548531651 ] } }, -{ "type": "Feature", "properties": { "_index": 459, "bedlevel": 804.60003662109375, "branchid": "pipe_12_E4;pipe_12_E5", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_457_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 3.5938825885944809e-07, "index_right": 464, "nodeid": "1384399.587644_5857137.085412", "id": "1384399.587644_5857137.085412", "name": "manhole_457_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384399.587644136510789, 5857137.08541233278811 ] } }, -{ "type": "Feature", "properties": { "_index": 460, "bedlevel": 804.60003662109375, "branchid": "pipe_12_E5;pipe_12_E6", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_458_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 2.1058202778609514e-07, "index_right": 465, "nodeid": "1384425.044660_5857171.763873", "id": "1384425.044660_5857171.763873", "name": "manhole_458_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384425.04465982504189, 5857171.763873117044568 ] } }, -{ "type": "Feature", "properties": { "_index": 461, "bedlevel": 792.9000244140625, "branchid": "pipe_12_E6;pipe_15_E0;pipe_17_E0", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_459_generated", "shape": null, "area": 0.64, "streetlevel": 795.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 795.9000244140625, "distance_right": 1.0521498026447859e-07, "index_right": 466, "nodeid": "1384456.866521_5857200.577978", "id": "1384456.866521_5857200.577978", "name": "manhole_459_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384456.866520966170356, 5857200.577977900393307 ] } }, -{ "type": "Feature", "properties": { "_index": 462, "bedlevel": 792.9000244140625, "branchid": "pipe_15_E0", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_460_generated", "shape": null, "area": 0.64, "streetlevel": 795.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 795.9000244140625, "distance_right": 5.3722077541611869e-07, "index_right": 467, "nodeid": "1384480.774831_5857195.244455", "id": "1384480.774831_5857195.244455", "name": "manhole_460_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384480.774830641923472, 5857195.244455400854349 ] } }, -{ "type": "Feature", "properties": { "_index": 463, "bedlevel": 802.0, "branchid": "pipe_17_E0;pipe_18_E0;pipe_19_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_461_generated", "shape": null, "area": 0.64, "streetlevel": 805.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 805.0, "distance_right": 1.9196784202574641e-07, "index_right": 468, "nodeid": "1384478.871156_5857219.682923", "id": "1384478.871156_5857219.682923", "name": "manhole_461_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384478.871156033361331, 5857219.682923189364374 ] } }, -{ "type": "Feature", "properties": { "_index": 464, "bedlevel": 802.0, "branchid": "pipe_18_E0;pipe_19_E0", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_462_generated", "shape": null, "area": 0.64, "streetlevel": 805.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 805.0, "distance_right": 4.2284615434076742e-07, "index_right": 469, "nodeid": "1384493.329777_5857201.952338", "id": "1384493.329777_5857201.952338", "name": "manhole_462_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384493.329776774393395, 5857201.952337642200291 ] } }, -{ "type": "Feature", "properties": { "_index": 465, "bedlevel": 802.0, "branchid": "pipe_19_E0;pipe_19_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_463_generated", "shape": null, "area": 0.64, "streetlevel": 805.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 805.0, "distance_right": 2.1723785306021382e-07, "index_right": 470, "nodeid": "1384511.321100_5857246.008046", "id": "1384511.321100_5857246.008046", "name": "manhole_463_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384511.321100181667134, 5857246.008046119473875 ] } }, -{ "type": "Feature", "properties": { "_index": 467, "bedlevel": 802.0, "branchid": "pipe_20_E0", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_464_generated", "shape": null, "area": 0.64, "streetlevel": 805.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 805.0, "distance_right": 3.7745466738450301e-07, "index_right": 471, "nodeid": "1384512.484967_5857248.858029", "id": "1384512.484967_5857248.858029", "name": "manhole_464_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384512.484966830350459, 5857248.858029337599874 ] } }, -{ "type": "Feature", "properties": { "_index": 467, "bedlevel": 793.29998779296875, "branchid": "pipe_20_E0;pipe_20_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_465_generated", "shape": null, "area": 0.64, "streetlevel": 796.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 796.29998779296875, "distance_right": 2.9467429280942488e-07, "index_right": 472, "nodeid": "1384550.208547_5857281.609187", "id": "1384550.208547_5857281.609187", "name": "manhole_465_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384550.208547196350992, 5857281.609186780638993 ] } }, -{ "type": "Feature", "properties": { "_index": 468, "bedlevel": 793.29998779296875, "branchid": "pipe_20_E1;pipe_20_E2", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_466_generated", "shape": null, "area": 0.64, "streetlevel": 796.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 796.29998779296875, "distance_right": 4.9191202976319131e-07, "index_right": 473, "nodeid": "1384587.932128_5857314.360344", "id": "1384587.932128_5857314.360344", "name": "manhole_466_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384587.932127562351525, 5857314.360344224609435 ] } }, -{ "type": "Feature", "properties": { "_index": 469, "bedlevel": 806.10003662109375, "branchid": "pipe_20_E2;pipe_20_E3", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_467_generated", "shape": null, "area": 0.64, "streetlevel": 809.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 809.10003662109375, "distance_right": 3.5761089101492169e-07, "index_right": 474, "nodeid": "1384608.456867_5857358.785165", "id": "1384608.456867_5857358.785165", "name": "manhole_467_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384608.456866907887161, 5857358.785165345296264 ] } }, -{ "type": "Feature", "properties": { "_index": 470, "bedlevel": 806.10003662109375, "branchid": "pipe_20_E3;pipe_20_E4", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_468_generated", "shape": null, "area": 0.64, "streetlevel": 809.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 809.10003662109375, "distance_right": 3.4869916151305031e-07, "index_right": 475, "nodeid": "1384624.966164_5857405.935456", "id": "1384624.966164_5857405.935456", "name": "manhole_468_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384624.966163935838267, 5857405.935456342995167 ] } }, -{ "type": "Feature", "properties": { "_index": 471, "bedlevel": 791.29998779296875, "branchid": "pipe_20_E4;pipe_20_E5", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_469_generated", "shape": null, "area": 0.64, "streetlevel": 794.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 794.29998779296875, "distance_right": 5.3270430114269587e-07, "index_right": 476, "nodeid": "1384639.938245_5857453.586039", "id": "1384639.938245_5857453.586039", "name": "manhole_469_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384639.938245237572119, 5857453.586039477027953 ] } }, -{ "type": "Feature", "properties": { "_index": 472, "bedlevel": 809.4000244140625, "branchid": "pipe_20_E5;pipe_20_E6", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_470_generated", "shape": null, "area": 0.64, "streetlevel": 812.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 812.4000244140625, "distance_right": 4.9705781674062353e-07, "index_right": 477, "nodeid": "1384654.342376_5857501.421464", "id": "1384654.342376_5857501.421464", "name": "manhole_470_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384654.3423755497206, 5857501.421464210376143 ] } }, -{ "type": "Feature", "properties": { "_index": 473, "bedlevel": 809.4000244140625, "branchid": "pipe_20_E6;pipe_20_E7", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_471_generated", "shape": null, "area": 0.64, "streetlevel": 812.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 812.4000244140625, "distance_right": 2.7046393679534545e-07, "index_right": 478, "nodeid": "1384665.748858_5857550.055336", "id": "1384665.748858_5857550.055336", "name": "manhole_471_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384665.748858094681054, 5857550.055336253717542 ] } }, -{ "type": "Feature", "properties": { "_index": 474, "bedlevel": 809.4000244140625, "branchid": "pipe_20_E7;pipe_20_E8", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_472_generated", "shape": null, "area": 0.64, "streetlevel": 812.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 812.4000244140625, "distance_right": 4.1869249149785678e-07, "index_right": 479, "nodeid": "1384677.047727_5857598.717872", "id": "1384677.047727_5857598.717872", "name": "manhole_472_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384677.04772660904564, 5857598.717872150242329 ] } }, -{ "type": "Feature", "properties": { "_index": 475, "bedlevel": 815.9000244140625, "branchid": "pipe_20_E8;pipe_20_E9", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_473_generated", "shape": null, "area": 0.64, "streetlevel": 818.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 818.9000244140625, "distance_right": 1.315680624067599e-07, "index_right": 480, "nodeid": "1384688.346595_5857647.380408", "id": "1384688.346595_5857647.380408", "name": "manhole_473_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384688.346595123410225, 5857647.380408045835793 ] } }, -{ "type": "Feature", "properties": { "_index": 476, "bedlevel": 815.9000244140625, "branchid": "pipe_20_E9;pipe_20_E10", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_474_generated", "shape": null, "area": 0.64, "streetlevel": 818.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 818.9000244140625, "distance_right": 3.6700491044701186e-07, "index_right": 481, "nodeid": "1384699.645464_5857696.042944", "id": "1384699.645464_5857696.042944", "name": "manhole_474_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384699.64546363777481, 5857696.042943941429257 ] } }, -{ "type": "Feature", "properties": { "_index": 477, "bedlevel": 788.0, "branchid": "pipe_20_E10;pipe_20_E11", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_475_generated", "shape": null, "area": 0.64, "streetlevel": 791.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 791.0, "distance_right": 2.2220693550766025e-07, "index_right": 482, "nodeid": "1384710.944332_5857744.705480", "id": "1384710.944332_5857744.705480", "name": "manhole_475_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384710.944332152139395, 5857744.705479837954044 ] } }, -{ "type": "Feature", "properties": { "_index": 478, "bedlevel": 768.9000244140625, "branchid": "pipe_20_E11;pipe_20_E12", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_476_generated", "shape": null, "area": 0.64, "streetlevel": 771.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 771.9000244140625, "distance_right": 4.8028085976613379e-07, "index_right": 483, "nodeid": "1384726.848783_5857791.671308", "id": "1384726.848783_5857791.671308", "name": "manhole_476_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384726.848783193388954, 5857791.671307560056448 ] } }, -{ "type": "Feature", "properties": { "_index": 479, "bedlevel": 768.9000244140625, "branchid": "pipe_20_E12;pipe_20_E13", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_477_generated", "shape": null, "area": 0.64, "streetlevel": 771.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 771.9000244140625, "distance_right": 5.9588726492505702e-07, "index_right": 484, "nodeid": "1384753.929338_5857833.199649", "id": "1384753.929338_5857833.199649", "name": "manhole_477_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384753.929338480113074, 5857833.199649352580309 ] } }, -{ "type": "Feature", "properties": { "_index": 480, "bedlevel": 768.9000244140625, "branchid": "pipe_20_E13;pipe_20_E14", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_478_generated", "shape": null, "area": 0.64, "streetlevel": 771.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 771.9000244140625, "distance_right": 3.5161620977039942e-07, "index_right": 485, "nodeid": "1384783.627482_5857873.006575", "id": "1384783.627482_5857873.006575", "name": "manhole_478_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384783.627482200739905, 5857873.006575288251042 ] } }, -{ "type": "Feature", "properties": { "_index": 481, "bedlevel": 788.0, "branchid": "pipe_20_E14;pipe_20_E15", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_479_generated", "shape": null, "area": 0.64, "streetlevel": 791.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 791.0, "distance_right": 3.7131283277773026e-07, "index_right": 486, "nodeid": "1384795.018453_5857920.637507", "id": "1384795.018453_5857920.637507", "name": "manhole_479_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384795.018452654592693, 5857920.637507135979831 ] } }, -{ "type": "Feature", "properties": { "_index": 482, "bedlevel": 788.0, "branchid": "pipe_20_E15;pipe_20_E16", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_480_generated", "shape": null, "area": 0.64, "streetlevel": 791.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 791.0, "distance_right": 3.6017576108266254e-07, "index_right": 487, "nodeid": "1384785.075932_5857969.445633", "id": "1384785.075932_5857969.445633", "name": "manhole_480_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384785.075932276435196, 5857969.445633230730891 ] } }, -{ "type": "Feature", "properties": { "_index": 483, "bedlevel": 817.10003662109375, "branchid": "pipe_20_E16;pipe_20_E17", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_481_generated", "shape": null, "area": 0.64, "streetlevel": 820.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 820.10003662109375, "distance_right": 3.2088624364960761e-07, "index_right": 488, "nodeid": "1384771.479073_5858017.516750", "id": "1384771.479073_5858017.516750", "name": "manhole_481_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384771.479073295136914, 5858017.516749874688685 ] } }, -{ "type": "Feature", "properties": { "_index": 484, "bedlevel": 817.10003662109375, "branchid": "pipe_20_E17;pipe_20_E18", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_482_generated", "shape": null, "area": 0.64, "streetlevel": 820.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 820.10003662109375, "distance_right": 4.4953182233117254e-07, "index_right": 489, "nodeid": "1384763.325190_5858066.675425", "id": "1384763.325190_5858066.675425", "name": "manhole_482_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384763.32518996251747, 5858066.675425447523594 ] } }, -{ "type": "Feature", "properties": { "_index": 485, "bedlevel": 817.10003662109375, "branchid": "pipe_20_E18;pipe_20_E19", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_483_generated", "shape": null, "area": 0.64, "streetlevel": 820.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 820.10003662109375, "distance_right": 5.3880955032763759e-07, "index_right": 490, "nodeid": "1384757.405407_5858116.280496", "id": "1384757.405407_5858116.280496", "name": "manhole_483_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384757.405406558187678, 5858116.280495692044497 ] } }, -{ "type": "Feature", "properties": { "_index": 486, "bedlevel": 844.0, "branchid": "pipe_20_E19;pipe_20_E20", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_484_generated", "shape": null, "area": 0.64, "streetlevel": 847.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 847.0, "distance_right": 5.3637227265526465e-07, "index_right": 491, "nodeid": "1384746.211964_5858164.956997", "id": "1384746.211964_5858164.956997", "name": "manhole_484_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384746.211964494548738, 5858164.956996791996062 ] } }, -{ "type": "Feature", "properties": { "_index": 487, "bedlevel": 844.0, "branchid": "pipe_20_E20;pipe_20_E21", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_485_generated", "shape": null, "area": 0.64, "streetlevel": 847.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 847.0, "distance_right": 4.5977538296708937e-07, "index_right": 492, "nodeid": "1384738.028055_5858213.862444", "id": "1384738.028055_5858213.862444", "name": "manhole_485_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384738.028054837835953, 5858213.862443570047617 ] } }, -{ "type": "Feature", "properties": { "_index": 488, "bedlevel": 844.0, "branchid": "pipe_20_E21;pipe_20_E22", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_486_generated", "shape": null, "area": 0.64, "streetlevel": 847.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 847.0, "distance_right": 1.3906988183523212e-07, "index_right": 493, "nodeid": "1384756.479259_5858259.218586", "id": "1384756.479259_5858259.218586", "name": "manhole_486_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384756.479259133106098, 5858259.218586039729416 ] } }, -{ "type": "Feature", "properties": { "_index": 489, "bedlevel": 830.20001220703125, "branchid": "pipe_20_E22;pipe_20_E23", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_487_generated", "shape": null, "area": 0.64, "streetlevel": 833.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 833.20001220703125, "distance_right": 4.957432448534482e-07, "index_right": 494, "nodeid": "1384792.653981_5858293.253396", "id": "1384792.653981_5858293.253396", "name": "manhole_487_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384792.653981153853238, 5858293.25339647103101 ] } }, -{ "type": "Feature", "properties": { "_index": 490, "bedlevel": 759.29998779296875, "branchid": "pipe_20_E23;pipe_20_E24", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_488_generated", "shape": null, "area": 0.64, "streetlevel": 762.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.29998779296875, "distance_right": 3.4494981559446402e-07, "index_right": 495, "nodeid": "1384839.146884_5858310.949097", "id": "1384839.146884_5858310.949097", "name": "manhole_488_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384839.146884107263759, 5858310.949097327888012 ] } }, -{ "type": "Feature", "properties": { "_index": 491, "bedlevel": 759.29998779296875, "branchid": "pipe_20_E24;pipe_20_E25", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_489_generated", "shape": null, "area": 0.64, "streetlevel": 762.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.29998779296875, "distance_right": 4.1482822303052493e-07, "index_right": 496, "nodeid": "1384888.517510_5858307.535864", "id": "1384888.517510_5858307.535864", "name": "manhole_489_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384888.517509665805846, 5858307.535864246077836 ] } }, -{ "type": "Feature", "properties": { "_index": 492, "bedlevel": 748.0, "branchid": "pipe_20_E25;pipe_20_E26", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_490_generated", "shape": null, "area": 0.64, "streetlevel": 751.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 751.0, "distance_right": 1.9615342642219019e-07, "index_right": 497, "nodeid": "1384936.622763_5858294.068231", "id": "1384936.622763_5858294.068231", "name": "manhole_490_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384936.622762819286436, 5858294.068231076002121 ] } }, -{ "type": "Feature", "properties": { "_index": 493, "bedlevel": 748.0, "branchid": "pipe_20_E26;pipe_20_E27", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_491_generated", "shape": null, "area": 0.64, "streetlevel": 751.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 751.0, "distance_right": 5.3404041479262363e-07, "index_right": 498, "nodeid": "1384984.637113_5858280.272530", "id": "1384984.637113_5858280.272530", "name": "manhole_491_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384984.637113286415115, 5858280.272530450485647 ] } }, -{ "type": "Feature", "properties": { "_index": 494, "bedlevel": 740.20001220703125, "branchid": "pipe_20_E27;pipe_20_E28", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_492_generated", "shape": null, "area": 0.64, "streetlevel": 743.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 743.20001220703125, "distance_right": 4.4808866815921511e-07, "index_right": 499, "nodeid": "1385032.633651_5858266.414711", "id": "1385032.633651_5858266.414711", "name": "manhole_492_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385032.633651287527755, 5858266.414710656739771 ] } }, -{ "type": "Feature", "properties": { "_index": 495, "bedlevel": 740.20001220703125, "branchid": "pipe_20_E28;pipe_20_E29", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_493_generated", "shape": null, "area": 0.64, "streetlevel": 743.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 743.20001220703125, "distance_right": 4.5997725205119854e-07, "index_right": 500, "nodeid": "1385081.886840_5858258.136645", "id": "1385081.886840_5858258.136645", "name": "manhole_493_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385081.886840383987874, 5858258.136644747108221 ] } }, -{ "type": "Feature", "properties": { "_index": 496, "bedlevel": 744.60003662109375, "branchid": "pipe_20_E29;pipe_20_E30", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_494_generated", "shape": null, "area": 0.64, "streetlevel": 747.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 747.60003662109375, "distance_right": 5.1289583885473558e-07, "index_right": 501, "nodeid": "1385131.310464_5858263.211211", "id": "1385131.310464_5858263.211211", "name": "manhole_494_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385131.310463621048257, 5858263.211211345158517 ] } }, -{ "type": "Feature", "properties": { "_index": 497, "bedlevel": 753.79998779296875, "branchid": "pipe_20_E30;pipe_20_E31", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_495_generated", "shape": null, "area": 0.64, "streetlevel": 756.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 756.79998779296875, "distance_right": 1.466862620517437e-07, "index_right": 502, "nodeid": "1385177.729395_5858281.168494", "id": "1385177.729395_5858281.168494", "name": "manhole_495_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385177.729395114118233, 5858281.168494092300534 ] } }, -{ "type": "Feature", "properties": { "_index": 498, "bedlevel": 755.9000244140625, "branchid": "pipe_20_E31;pipe_20_E32", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_496_generated", "shape": null, "area": 0.64, "streetlevel": 758.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 758.9000244140625, "distance_right": 3.6395302459551237e-07, "index_right": 503, "nodeid": "1385219.956519_5858307.842426", "id": "1385219.956519_5858307.842426", "name": "manhole_496_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385219.95651927171275, 5858307.84242575801909 ] } }, -{ "type": "Feature", "properties": { "_index": 499, "bedlevel": 755.9000244140625, "branchid": "pipe_20_E32;pipe_20_E33", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_497_generated", "shape": null, "area": 0.64, "streetlevel": 758.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 758.9000244140625, "distance_right": 1.8879808927425897e-07, "index_right": 504, "nodeid": "1385261.864507_5858335.034840", "id": "1385261.864507_5858335.034840", "name": "manhole_497_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385261.864506913116202, 5858335.034840167500079 ] } }, -{ "type": "Feature", "properties": { "_index": 500, "bedlevel": 753.29998779296875, "branchid": "pipe_20_E33;pipe_20_E34", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_498_generated", "shape": null, "area": 0.64, "streetlevel": 756.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 756.29998779296875, "distance_right": 5.419301661765223e-07, "index_right": 505, "nodeid": "1385305.658712_5858358.964501", "id": "1385305.658712_5858358.964501", "name": "manhole_498_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385305.658712412696332, 5858358.964500648900867 ] } }, -{ "type": "Feature", "properties": { "_index": 501, "bedlevel": 753.29998779296875, "branchid": "pipe_20_E34;pipe_20_E35", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_499_generated", "shape": null, "area": 0.64, "streetlevel": 756.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 756.29998779296875, "distance_right": 1.8543977824422103e-07, "index_right": 506, "nodeid": "1385350.136276_5858381.712098", "id": "1385350.136276_5858381.712098", "name": "manhole_499_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385350.136275847908109, 5858381.712097893469036 ] } }, -{ "type": "Feature", "properties": { "_index": 502, "bedlevel": 747.79998779296875, "branchid": "pipe_20_E35;pipe_20_E36", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_500_generated", "shape": null, "area": 0.64, "streetlevel": 750.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 750.79998779296875, "distance_right": 3.5987401233780288e-07, "index_right": 507, "nodeid": "1385394.617425_5858404.452682", "id": "1385394.617425_5858404.452682", "name": "manhole_500_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385394.617425152566284, 5858404.452682325616479 ] } }, -{ "type": "Feature", "properties": { "_index": 503, "bedlevel": 757.20001220703125, "branchid": "pipe_20_E36;pipe_20_E37", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_501_generated", "shape": null, "area": 0.64, "streetlevel": 760.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 760.20001220703125, "distance_right": 4.601393315218742e-07, "index_right": 508, "nodeid": "1385439.245916_5858426.901899", "id": "1385439.245916_5858426.901899", "name": "manhole_501_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385439.245915542822331, 5858426.901898948475718 ] } }, -{ "type": "Feature", "properties": { "_index": 504, "bedlevel": 751.29998779296875, "branchid": "pipe_20_E37;pipe_20_E38", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_502_generated", "shape": null, "area": 0.64, "streetlevel": 754.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 754.29998779296875, "distance_right": 2.101491005489345e-07, "index_right": 509, "nodeid": "1385483.926140_5858449.248809", "id": "1385483.926140_5858449.248809", "name": "manhole_502_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385483.926139793125913, 5858449.248809035867453 ] } }, -{ "type": "Feature", "properties": { "_index": 505, "bedlevel": 751.29998779296875, "branchid": "pipe_20_E38;pipe_20_E39", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_503_generated", "shape": null, "area": 0.64, "streetlevel": 754.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 754.29998779296875, "distance_right": 1.7103720699768628e-07, "index_right": 510, "nodeid": "1385525.860647_5858475.863234", "id": "1385525.860647_5858475.863234", "name": "manhole_503_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385525.860647091642022, 5858475.8632338559255 ] } }, -{ "type": "Feature", "properties": { "_index": 506, "bedlevel": 751.29998779296875, "branchid": "pipe_20_E39;pipe_20_E40", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_504_generated", "shape": null, "area": 0.64, "streetlevel": 754.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 754.29998779296875, "distance_right": 4.4366280841908402e-07, "index_right": 511, "nodeid": "1385553.357332_5858517.404888", "id": "1385553.357332_5858517.404888", "name": "manhole_504_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385553.357332118786871, 5858517.404887572862208 ] } }, -{ "type": "Feature", "properties": { "_index": 507, "bedlevel": 748.70001220703125, "branchid": "pipe_20_E40;pipe_20_E41", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_505_generated", "shape": null, "area": 0.64, "streetlevel": 751.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 751.70001220703125, "distance_right": 3.4367514486766495e-07, "index_right": 512, "nodeid": "1385579.617479_5858559.686365", "id": "1385579.617479_5858559.686365", "name": "manhole_505_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385579.617479301057756, 5858559.686364834196866 ] } }, -{ "type": "Feature", "properties": { "_index": 508, "bedlevel": 748.70001220703125, "branchid": "pipe_20_E41;pipe_20_E42", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_506_generated", "shape": null, "area": 0.64, "streetlevel": 751.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 751.70001220703125, "distance_right": 2.5610704050949026e-07, "index_right": 513, "nodeid": "1385621.905694_5858585.068031", "id": "1385621.905694_5858585.068031", "name": "manhole_506_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385621.905693766893819, 5858585.068030893802643 ] } }, -{ "type": "Feature", "properties": { "_index": 509, "bedlevel": 747.9000244140625, "branchid": "pipe_20_E42;pipe_20_E43", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_507_generated", "shape": null, "area": 0.64, "streetlevel": 750.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 750.9000244140625, "distance_right": 3.6119177667836709e-07, "index_right": 514, "nodeid": "1385664.027274_5858611.351027", "id": "1385664.027274_5858611.351027", "name": "manhole_507_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385664.027273919200525, 5858611.351026647724211 ] } }, -{ "type": "Feature", "properties": { "_index": 510, "bedlevel": 747.9000244140625, "branchid": "pipe_20_E43;pipe_20_E44", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_508_generated", "shape": null, "area": 0.64, "streetlevel": 750.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 750.9000244140625, "distance_right": 4.2503991281748145e-07, "index_right": 515, "nodeid": "1385700.387206_5858645.507955", "id": "1385700.387206_5858645.507955", "name": "manhole_508_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385700.387205619364977, 5858645.507954810746014 ] } }, -{ "type": "Feature", "properties": { "_index": 511, "bedlevel": 747.9000244140625, "branchid": "pipe_20_E44;pipe_20_E45", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_509_generated", "shape": null, "area": 0.64, "streetlevel": 750.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 750.9000244140625, "distance_right": 4.0335649518180225e-07, "index_right": 516, "nodeid": "1385734.601841_5858681.909405", "id": "1385734.601841_5858681.909405", "name": "manhole_509_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385734.601841112133116, 5858681.909404612146318 ] } }, -{ "type": "Feature", "properties": { "_index": 512, "bedlevel": 752.79998779296875, "branchid": "pipe_20_E45;pipe_20_E46", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_510_generated", "shape": null, "area": 0.64, "streetlevel": 755.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 755.79998779296875, "distance_right": 5.7125618808521589e-07, "index_right": 517, "nodeid": "1385768.816477_5858718.310854", "id": "1385768.816477_5858718.310854", "name": "manhole_510_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385768.816476604901254, 5858718.310854412615299 ] } }, -{ "type": "Feature", "properties": { "_index": 513, "bedlevel": 752.79998779296875, "branchid": "pipe_20_E46;pipe_20_E47", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_511_generated", "shape": null, "area": 0.64, "streetlevel": 755.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 755.79998779296875, "distance_right": 9.4215891635551309e-08, "index_right": 518, "nodeid": "1385802.200312_5858755.447310", "id": "1385802.200312_5858755.447310", "name": "manhole_511_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385802.200311921536922, 5858755.447309947572649 ] } }, -{ "type": "Feature", "properties": { "_index": 514, "bedlevel": 752.79998779296875, "branchid": "pipe_20_E47", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_512_generated", "shape": null, "area": 0.64, "streetlevel": 755.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 755.79998779296875, "distance_right": 4.9733410300668418e-07, "index_right": 519, "nodeid": "1385834.159462_5858793.844179", "id": "1385834.159462_5858793.844179", "name": "manhole_512_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385834.15946239954792, 5858793.844178703613579 ] } }, -{ "type": "Feature", "properties": { "_index": 515, "bedlevel": 753.29998779296875, "branchid": "pipe_21_E0", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_513_generated", "shape": null, "area": 0.64, "streetlevel": 756.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 756.29998779296875, "distance_right": 3.3313663649888272e-07, "index_right": 520, "nodeid": "1385352.471788_5858398.702550", "id": "1385352.471788_5858398.702550", "name": "manhole_513_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385352.471788094611838, 5858398.70255031902343 ] } }, -{ "type": "Feature", "properties": { "_index": 515, "bedlevel": 762.0, "branchid": "pipe_21_E0;pipe_21_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_514_generated", "shape": null, "area": 0.64, "streetlevel": 765.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 765.0, "distance_right": 5.4077632442523464e-07, "index_right": 521, "nodeid": "1385323.609450_5858430.098599", "id": "1385323.609450_5858430.098599", "name": "manhole_514_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385323.609449510695413, 5858430.098599229939282 ] } }, -{ "type": "Feature", "properties": { "_index": 516, "bedlevel": 762.0, "branchid": "pipe_21_E1;pipe_21_E2", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_515_generated", "shape": null, "area": 0.64, "streetlevel": 765.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 765.0, "distance_right": 2.9393603149665491e-07, "index_right": 522, "nodeid": "1385286.388776_5858419.306092", "id": "1385286.388776_5858419.306092", "name": "manhole_515_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385286.388775944709778, 5858419.306091710925102 ] } }, -{ "type": "Feature", "properties": { "_index": 517, "bedlevel": 755.9000244140625, "branchid": "pipe_21_E2;pipe_21_E3", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_516_generated", "shape": null, "area": 0.64, "streetlevel": 758.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 758.9000244140625, "distance_right": 4.2516335479223613e-07, "index_right": 523, "nodeid": "1385252.458743_5858394.201655", "id": "1385252.458743_5858394.201655", "name": "manhole_516_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385252.458742934046313, 5858394.201654580421746 ] } }, -{ "type": "Feature", "properties": { "_index": 518, "bedlevel": 755.9000244140625, "branchid": "pipe_21_E3;pipe_21_E4", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_517_generated", "shape": null, "area": 0.64, "streetlevel": 758.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 758.9000244140625, "distance_right": 5.5811889877153229e-07, "index_right": 524, "nodeid": "1385217.536378_5858369.723605", "id": "1385217.536378_5858369.723605", "name": "manhole_517_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385217.536378393415362, 5858369.72360460460186 ] } }, -{ "type": "Feature", "properties": { "_index": 519, "bedlevel": 753.79998779296875, "branchid": "pipe_21_E4", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_518_generated", "shape": null, "area": 0.64, "streetlevel": 756.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 756.79998779296875, "distance_right": 5.341153742051576e-07, "index_right": 525, "nodeid": "1385177.877520_5858363.975667", "id": "1385177.877520_5858363.975667", "name": "manhole_518_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385177.877519500209019, 5858363.975667187944055 ] } }, -{ "type": "Feature", "properties": { "_index": 520, "bedlevel": 810.60003662109375, "branchid": "pipe_23_E0", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_519_generated", "shape": null, "area": 0.64, "streetlevel": 813.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 813.60003662109375, "distance_right": 3.7932856782999725e-07, "index_right": 526, "nodeid": "1384748.107252_5858475.465394", "id": "1384748.107252_5858475.465394", "name": "manhole_519_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384748.107251951703802, 5858475.46539437584579 ] } }, -{ "type": "Feature", "properties": { "_index": 520, "bedlevel": 810.60003662109375, "branchid": "pipe_23_E0;pipe_23_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_520_generated", "shape": null, "area": 0.64, "streetlevel": 813.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 813.60003662109375, "distance_right": 1.5235470245872061e-07, "index_right": 527, "nodeid": "1384773.662756_5858482.028829", "id": "1384773.662756_5858482.028829", "name": "manhole_520_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384773.662756133358926, 5858482.028828926384449 ] } }, -{ "type": "Feature", "properties": { "_index": 521, "bedlevel": 810.60003662109375, "branchid": "pipe_23_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_521_generated", "shape": null, "area": 0.64, "streetlevel": 813.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 813.60003662109375, "distance_right": 5.7240456036556167e-07, "index_right": 528, "nodeid": "1384799.218260_5858488.592263", "id": "1384799.218260_5858488.592263", "name": "manhole_521_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384799.21826031524688, 5858488.592263477854431 ] } }, -{ "type": "Feature", "properties": { "_index": 522, "bedlevel": 759.9000244140625, "branchid": "pipe_24_E0;pipe_26_E0;pipe_29_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_522_generated", "shape": null, "area": 0.64, "streetlevel": 762.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.9000244140625, "distance_right": 4.1723277328328253e-07, "index_right": 529, "nodeid": "1385831.554475_5858837.476551", "id": "1385831.554475_5858837.476551", "name": "manhole_522_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385831.554474999429658, 5858837.476550582796335 ] } }, -{ "type": "Feature", "properties": { "_index": 522, "bedlevel": 748.4000244140625, "branchid": "pipe_24_E0;pipe_24_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_523_generated", "shape": null, "area": 0.64, "streetlevel": 751.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 751.4000244140625, "distance_right": 3.5562508610116324e-07, "index_right": 530, "nodeid": "1385834.933234_5858795.367518", "id": "1385834.933234_5858795.367518", "name": "manhole_523_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385834.933234154479578, 5858795.367517679929733 ] } }, -{ "type": "Feature", "properties": { "_index": 523, "bedlevel": 756.70001220703125, "branchid": "pipe_24_E1;pipe_26_E0", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_524_generated", "shape": null, "area": 0.64, "streetlevel": 759.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 759.70001220703125, "distance_right": 1.6097894538102849e-07, "index_right": 531, "nodeid": "1385855.640896_5858836.135080", "id": "1385855.640896_5858836.135080", "name": "manhole_524_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385855.640895856311545, 5858836.135079927742481 ] } }, -{ "type": "Feature", "properties": { "_index": 524, "bedlevel": 783.79998779296875, "branchid": "pipe_25_E0", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_525_generated", "shape": null, "area": 0.64, "streetlevel": 786.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 786.79998779296875, "distance_right": 4.9875171671174047e-07, "index_right": 532, "nodeid": "1385425.871742_5858809.522039", "id": "1385425.871742_5858809.522039", "name": "manhole_525_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385425.871741503709927, 5858809.522038951516151 ] } }, -{ "type": "Feature", "properties": { "_index": 524, "bedlevel": 788.20001220703125, "branchid": "pipe_25_E0;pipe_25_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_526_generated", "shape": null, "area": 0.64, "streetlevel": 791.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 791.20001220703125, "distance_right": 5.7550611101994379e-07, "index_right": 533, "nodeid": "1385446.216240_5858844.397749", "id": "1385446.216240_5858844.397749", "name": "manhole_526_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385446.216239683330059, 5858844.397748519666493 ] } }, -{ "type": "Feature", "properties": { "_index": 525, "bedlevel": 788.20001220703125, "branchid": "pipe_25_E1;pipe_25_E2", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_527_generated", "shape": null, "area": 0.64, "streetlevel": 791.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 791.20001220703125, "distance_right": 2.8135076174496163e-07, "index_right": 534, "nodeid": "1385453.998638_5858886.437654", "id": "1385453.998638_5858886.437654", "name": "manhole_527_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385453.998638280900195, 5858886.437654017470777 ] } }, -{ "type": "Feature", "properties": { "_index": 526, "bedlevel": 780.0, "branchid": "pipe_25_E2", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_528_generated", "shape": null, "area": 0.64, "streetlevel": 783.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 783.0, "distance_right": 4.913263386404469e-07, "index_right": 535, "nodeid": "1385472.218053_5858925.273073", "id": "1385472.218053_5858925.273073", "name": "manhole_528_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385472.218053022632375, 5858925.273072509095073 ] } }, -{ "type": "Feature", "properties": { "_index": 528, "bedlevel": 756.70001220703125, "branchid": "pipe_29_E0", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_529_generated", "shape": null, "area": 0.64, "streetlevel": 759.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 759.70001220703125, "distance_right": 2.0428258687376185e-07, "index_right": 536, "nodeid": "1385861.372514_5858893.832569", "id": "1385861.372514_5858893.832569", "name": "manhole_529_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385861.372513797832653, 5858893.832569030113518 ] } }, -{ "type": "Feature", "properties": { "_index": 528, "bedlevel": 756.70001220703125, "branchid": "pipe_29_E0;pipe_29_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_530_generated", "shape": null, "area": 0.64, "streetlevel": 759.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 759.70001220703125, "distance_right": 1.9678914319064008e-07, "index_right": 537, "nodeid": "1385844.630084_5858865.848266", "id": "1385844.630084_5858865.848266", "name": "manhole_530_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385844.630084188189358, 5858865.848266057670116 ] } }, -{ "type": "Feature", "properties": { "_index": 530, "bedlevel": 766.4000244140625, "branchid": "pipe_30_E0", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_531_generated", "shape": null, "area": 0.64, "streetlevel": 769.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 769.4000244140625, "distance_right": 1.0826199317136784e-07, "index_right": 538, "nodeid": "1387137.223009_5858981.723107", "id": "1387137.223009_5858981.723107", "name": "manhole_531_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387137.22300889948383, 5858981.723106959834695 ] } }, -{ "type": "Feature", "properties": { "_index": 530, "bedlevel": 766.4000244140625, "branchid": "pipe_30_E0;pipe_30_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_532_generated", "shape": null, "area": 0.64, "streetlevel": 769.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 769.4000244140625, "distance_right": 3.686684848268439e-07, "index_right": 539, "nodeid": "1387148.048593_5859026.366798", "id": "1387148.048593_5859026.366798", "name": "manhole_532_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387148.04859330272302, 5859026.366797789931297 ] } }, -{ "type": "Feature", "properties": { "_index": 531, "bedlevel": 759.60003662109375, "branchid": "pipe_30_E1;pipe_30_E2", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_533_generated", "shape": null, "area": 0.64, "streetlevel": 762.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.60003662109375, "distance_right": 5.7761078259871499e-07, "index_right": 540, "nodeid": "1387119.959376_5859056.934599", "id": "1387119.959376_5859056.934599", "name": "manhole_533_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387119.95937648974359, 5859056.934598693624139 ] } }, -{ "type": "Feature", "properties": { "_index": 532, "bedlevel": 759.60003662109375, "branchid": "pipe_30_E2;pipe_30_E3", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_534_generated", "shape": null, "area": 0.64, "streetlevel": 762.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.60003662109375, "distance_right": 4.8820694205349016e-07, "index_right": 541, "nodeid": "1387074.832296_5859065.301006", "id": "1387074.832296_5859065.301006", "name": "manhole_534_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387074.832296247361228, 5859065.30100557859987 ] } }, -{ "type": "Feature", "properties": { "_index": 533, "bedlevel": 752.79998779296875, "branchid": "pipe_30_E3;pipe_30_E4", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_535_generated", "shape": null, "area": 0.64, "streetlevel": 755.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 755.79998779296875, "distance_right": 3.374577181130728e-07, "index_right": 542, "nodeid": "1387030.356415_5859076.861371", "id": "1387030.356415_5859076.861371", "name": "manhole_535_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387030.356415221933275, 5859076.86137125454843 ] } }, -{ "type": "Feature", "properties": { "_index": 534, "bedlevel": 769.4000244140625, "branchid": "pipe_30_E4;pipe_30_E5", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_536_generated", "shape": null, "area": 0.64, "streetlevel": 772.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 772.4000244140625, "distance_right": 5.6152650214475575e-07, "index_right": 543, "nodeid": "1386986.427999_5859090.309648", "id": "1386986.427999_5859090.309648", "name": "manhole_536_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386986.427998587489128, 5859090.309648380614817 ] } }, -{ "type": "Feature", "properties": { "_index": 535, "bedlevel": 758.60003662109375, "branchid": "pipe_30_E5;pipe_30_E6", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_537_generated", "shape": null, "area": 0.64, "streetlevel": 761.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 761.60003662109375, "distance_right": 5.4995130325451761e-07, "index_right": 544, "nodeid": "1386945.966695_5859111.788387", "id": "1386945.966695_5859111.788387", "name": "manhole_537_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386945.966695382725447, 5859111.788386604748666 ] } }, -{ "type": "Feature", "properties": { "_index": 536, "bedlevel": 758.60003662109375, "branchid": "pipe_30_E6;pipe_30_E7", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_538_generated", "shape": null, "area": 0.64, "streetlevel": 761.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 761.60003662109375, "distance_right": 4.9633513749728012e-07, "index_right": 545, "nodeid": "1386905.771024_5859134.105929", "id": "1386905.771024_5859134.105929", "name": "manhole_538_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386905.77102447184734, 5859134.105928846634924 ] } }, -{ "type": "Feature", "properties": { "_index": 537, "bedlevel": 758.60003662109375, "branchid": "pipe_30_E7;pipe_32_E0;pipe_33_E0", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_539_generated", "shape": null, "area": 0.64, "streetlevel": 761.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 761.60003662109375, "distance_right": 2.7520069926497903e-07, "index_right": 546, "nodeid": "1386871.537448_5859162.609671", "id": "1386871.537448_5859162.609671", "name": "manhole_539_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386871.537448140559718, 5859162.609670763835311 ] } }, -{ "type": "Feature", "properties": { "_index": 538, "bedlevel": 758.60003662109375, "branchid": "pipe_32_E0;pipe_32_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_540_generated", "shape": null, "area": 0.64, "streetlevel": 761.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 761.60003662109375, "distance_right": 4.8588826730380931e-07, "index_right": 547, "nodeid": "1386921.106019_5859163.103915", "id": "1386921.106019_5859163.103915", "name": "manhole_540_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386921.106019288301468, 5859163.103915391489863 ] } }, -{ "type": "Feature", "properties": { "_index": 539, "bedlevel": 769.4000244140625, "branchid": "pipe_32_E1;pipe_32_E2", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_541_generated", "shape": null, "area": 0.64, "streetlevel": 772.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 772.4000244140625, "distance_right": 4.9582240878676894e-07, "index_right": 548, "nodeid": "1386970.627896_5859161.624509", "id": "1386970.627896_5859161.624509", "name": "manhole_541_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386970.627896018791944, 5859161.624508504755795 ] } }, -{ "type": "Feature", "properties": { "_index": 540, "bedlevel": 769.4000244140625, "branchid": "pipe_32_E2;pipe_32_E3", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_542_generated", "shape": null, "area": 0.64, "streetlevel": 772.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 772.4000244140625, "distance_right": 5.5451950297642449e-07, "index_right": 549, "nodeid": "1387019.993600_5859157.412991", "id": "1387019.993600_5859157.412991", "name": "manhole_542_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387019.993600395740941, 5859157.412991388700902 ] } }, -{ "type": "Feature", "properties": { "_index": 541, "bedlevel": 778.10003662109375, "branchid": "pipe_32_E3;pipe_32_E4", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_543_generated", "shape": null, "area": 0.64, "streetlevel": 781.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 781.10003662109375, "distance_right": 3.1035547522737893e-07, "index_right": 550, "nodeid": "1387069.191226_5859151.340004", "id": "1387069.191226_5859151.340004", "name": "manhole_543_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387069.191225855611265, 5859151.340004274621606 ] } }, -{ "type": "Feature", "properties": { "_index": 542, "bedlevel": 778.10003662109375, "branchid": "pipe_32_E4;pipe_32_E5", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_544_generated", "shape": null, "area": 0.64, "streetlevel": 781.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 781.10003662109375, "distance_right": 2.6808181379243751e-07, "index_right": 551, "nodeid": "1387118.547864_5859146.828393", "id": "1387118.547864_5859146.828393", "name": "manhole_544_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387118.547863835236058, 5859146.828392788767815 ] } }, -{ "type": "Feature", "properties": { "_index": 543, "bedlevel": 783.4000244140625, "branchid": "pipe_32_E5;pipe_32_E6", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_545_generated", "shape": null, "area": 0.64, "streetlevel": 786.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 786.4000244140625, "distance_right": 4.3713920793115639e-07, "index_right": 552, "nodeid": "1387167.916039_5859151.025294", "id": "1387167.916039_5859151.025294", "name": "manhole_545_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387167.916038708761334, 5859151.025294326245785 ] } }, -{ "type": "Feature", "properties": { "_index": 544, "bedlevel": 783.4000244140625, "branchid": "pipe_32_E6;pipe_32_E7", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_546_generated", "shape": null, "area": 0.64, "streetlevel": 786.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 786.4000244140625, "distance_right": 2.5205839433754474e-07, "index_right": 553, "nodeid": "1387217.282605_5859155.523035", "id": "1387217.282605_5859155.523035", "name": "manhole_546_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387217.282604865729809, 5859155.523034786805511 ] } }, -{ "type": "Feature", "properties": { "_index": 545, "bedlevel": 784.60003662109375, "branchid": "pipe_32_E7;pipe_32_E8", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_547_generated", "shape": null, "area": 0.64, "streetlevel": 787.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 787.60003662109375, "distance_right": 2.4966567906009152e-07, "index_right": 554, "nodeid": "1387266.649171_5859160.020775", "id": "1387266.649171_5859160.020775", "name": "manhole_547_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387266.649171022465453, 5859160.020775248296559 ] } }, -{ "type": "Feature", "properties": { "_index": 546, "bedlevel": 784.60003662109375, "branchid": "pipe_32_E8;pipe_32_E9", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_548_generated", "shape": null, "area": 0.64, "streetlevel": 787.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 787.60003662109375, "distance_right": 2.4506572779662508e-07, "index_right": 555, "nodeid": "1387315.831188_5859165.716173", "id": "1387315.831188_5859165.716173", "name": "manhole_548_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387315.831188223091885, 5859165.716172898188233 ] } }, -{ "type": "Feature", "properties": { "_index": 547, "bedlevel": 787.4000244140625, "branchid": "pipe_32_E9;pipe_32_E10", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_549_generated", "shape": null, "area": 0.64, "streetlevel": 790.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 790.4000244140625, "distance_right": 3.8513770845044176e-07, "index_right": 556, "nodeid": "1387364.261765_5859176.288154", "id": "1387364.261765_5859176.288154", "name": "manhole_549_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387364.261764668161049, 5859176.288154195994139 ] } }, -{ "type": "Feature", "properties": { "_index": 548, "bedlevel": 787.4000244140625, "branchid": "pipe_32_E10;pipe_32_E11", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_550_generated", "shape": null, "area": 0.64, "streetlevel": 790.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 790.4000244140625, "distance_right": 3.3210008430605365e-08, "index_right": 557, "nodeid": "1387411.186260_5859192.118345", "id": "1387411.186260_5859192.118345", "name": "manhole_550_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387411.186259990092367, 5859192.118345031514764 ] } }, -{ "type": "Feature", "properties": { "_index": 549, "bedlevel": 786.10003662109375, "branchid": "pipe_32_E11;pipe_32_E12", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_551_generated", "shape": null, "area": 0.64, "streetlevel": 789.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 789.10003662109375, "distance_right": 4.7365879545282216e-07, "index_right": 558, "nodeid": "1387455.544593_5859213.906052", "id": "1387455.544593_5859213.906052", "name": "manhole_551_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387455.544592748628929, 5859213.906051598489285 ] } }, -{ "type": "Feature", "properties": { "_index": 550, "bedlevel": 814.20001220703125, "branchid": "pipe_32_E12;pipe_32_E13", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_552_generated", "shape": null, "area": 0.64, "streetlevel": 817.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 817.20001220703125, "distance_right": 3.9529020951305247e-07, "index_right": 559, "nodeid": "1387490.610425_5859248.941349", "id": "1387490.610425_5859248.941349", "name": "manhole_552_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387490.610425172373652, 5859248.94134864397347 ] } }, -{ "type": "Feature", "properties": { "_index": 551, "bedlevel": 815.20001220703125, "branchid": "pipe_32_E13;pipe_32_E14", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_553_generated", "shape": null, "area": 0.64, "streetlevel": 818.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 818.20001220703125, "distance_right": 5.4228296261137134e-07, "index_right": 560, "nodeid": "1387525.979066_5859283.669168", "id": "1387525.979066_5859283.669168", "name": "manhole_553_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387525.979065561201423, 5859283.669168318621814 ] } }, -{ "type": "Feature", "properties": { "_index": 552, "bedlevel": 815.20001220703125, "branchid": "pipe_32_E14;pipe_32_E15", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_554_generated", "shape": null, "area": 0.64, "streetlevel": 818.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 818.20001220703125, "distance_right": 3.0182548578634254e-07, "index_right": 561, "nodeid": "1387563.532417_5859316.027063", "id": "1387563.532417_5859316.027063", "name": "manhole_554_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387563.532416822388768, 5859316.0270627560094 ] } }, -{ "type": "Feature", "properties": { "_index": 553, "bedlevel": 799.79998779296875, "branchid": "pipe_32_E15;pipe_32_E16", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_555_generated", "shape": null, "area": 0.64, "streetlevel": 802.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 802.79998779296875, "distance_right": 2.1107147677987274e-07, "index_right": 562, "nodeid": "1387601.085768_5859348.384957", "id": "1387601.085768_5859348.384957", "name": "manhole_555_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387601.085768083808944, 5859348.384957193396986 ] } }, -{ "type": "Feature", "properties": { "_index": 554, "bedlevel": 834.70001220703125, "branchid": "pipe_32_E16;pipe_32_E17", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_556_generated", "shape": null, "area": 0.64, "streetlevel": 837.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 837.70001220703125, "distance_right": 5.052127214258991e-07, "index_right": 563, "nodeid": "1387638.639119_5859380.742852", "id": "1387638.639119_5859380.742852", "name": "manhole_556_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387638.639119345229119, 5859380.742851630784571 ] } }, -{ "type": "Feature", "properties": { "_index": 555, "bedlevel": 834.70001220703125, "branchid": "pipe_32_E17;pipe_32_E18", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_557_generated", "shape": null, "area": 0.64, "streetlevel": 837.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 837.70001220703125, "distance_right": 3.9931398916583509e-07, "index_right": 564, "nodeid": "1387676.192471_5859413.100746", "id": "1387676.192471_5859413.100746", "name": "manhole_557_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387676.192470606416464, 5859413.100746068172157 ] } }, -{ "type": "Feature", "properties": { "_index": 556, "bedlevel": 825.79998779296875, "branchid": "pipe_32_E18;pipe_32_E19", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_558_generated", "shape": null, "area": 0.64, "streetlevel": 828.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 828.79998779296875, "distance_right": 5.1280958514562511e-07, "index_right": 565, "nodeid": "1387713.745822_5859445.458641", "id": "1387713.745822_5859445.458641", "name": "manhole_558_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387713.745821867836639, 5859445.45864050462842 ] } }, -{ "type": "Feature", "properties": { "_index": 557, "bedlevel": 825.79998779296875, "branchid": "pipe_32_E19;pipe_32_E20", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_559_generated", "shape": null, "area": 0.64, "streetlevel": 828.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 828.79998779296875, "distance_right": 4.9162563938563157e-07, "index_right": 566, "nodeid": "1387750.394378_5859478.825171", "id": "1387750.394378_5859478.825171", "name": "manhole_559_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387750.394377880264074, 5859478.825171477161348 ] } }, -{ "type": "Feature", "properties": { "_index": 558, "bedlevel": 851.29998779296875, "branchid": "pipe_32_E20;pipe_32_E21", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_560_generated", "shape": null, "area": 0.64, "streetlevel": 854.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 854.29998779296875, "distance_right": 2.2099050354582448e-07, "index_right": 567, "nodeid": "1387786.626277_5859512.656178", "id": "1387786.626277_5859512.656178", "name": "manhole_560_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387786.626276910537854, 5859512.656178202480078 ] } }, -{ "type": "Feature", "properties": { "_index": 559, "bedlevel": 851.29998779296875, "branchid": "pipe_32_E21;pipe_32_E22", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_561_generated", "shape": null, "area": 0.64, "streetlevel": 854.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 854.29998779296875, "distance_right": 9.454214361901851e-08, "index_right": 568, "nodeid": "1387822.858176_5859546.487185", "id": "1387822.858176_5859546.487185", "name": "manhole_561_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387822.858175940578803, 5859546.487184926867485 ] } }, -{ "type": "Feature", "properties": { "_index": 560, "bedlevel": 851.29998779296875, "branchid": "pipe_32_E22;pipe_32_E23", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_562_generated", "shape": null, "area": 0.64, "streetlevel": 854.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 854.29998779296875, "distance_right": 2.3615409729123986e-07, "index_right": 569, "nodeid": "1387850.662340_5859586.980696", "id": "1387850.662340_5859586.980696", "name": "manhole_562_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387850.662340233800933, 5859586.980695966631174 ] } }, -{ "type": "Feature", "properties": { "_index": 561, "bedlevel": 888.20001220703125, "branchid": "pipe_32_E23;pipe_32_E24", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_563_generated", "shape": null, "area": 0.64, "streetlevel": 891.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 891.20001220703125, "distance_right": 3.4181092772059008e-07, "index_right": 570, "nodeid": "1387868.193222_5859633.330901", "id": "1387868.193222_5859633.330901", "name": "manhole_563_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387868.193221996771172, 5859633.330900657922029 ] } }, -{ "type": "Feature", "properties": { "_index": 562, "bedlevel": 873.20001220703125, "branchid": "pipe_32_E24;pipe_32_E25", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_564_generated", "shape": null, "area": 0.64, "streetlevel": 876.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 876.20001220703125, "distance_right": 2.546826698671963e-07, "index_right": 571, "nodeid": "1387885.535610_5859679.769345", "id": "1387885.535610_5859679.769345", "name": "manhole_564_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387885.535610173596069, 5859679.769344814121723 ] } }, -{ "type": "Feature", "properties": { "_index": 563, "bedlevel": 873.20001220703125, "branchid": "pipe_32_E25;pipe_32_E26", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_565_generated", "shape": null, "area": 0.64, "streetlevel": 876.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 876.20001220703125, "distance_right": 5.6690489460937244e-07, "index_right": 572, "nodeid": "1387902.854486_5859726.216553", "id": "1387902.854486_5859726.216553", "name": "manhole_565_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387902.854485532967374, 5859726.216552678495646 ] } }, -{ "type": "Feature", "properties": { "_index": 564, "bedlevel": 895.29998779296875, "branchid": "pipe_32_E26;pipe_32_E27", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_566_generated", "shape": null, "area": 0.64, "streetlevel": 898.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 898.29998779296875, "distance_right": 6.0131442630219361e-07, "index_right": 573, "nodeid": "1387920.137465_5859772.677140", "id": "1387920.137465_5859772.677140", "name": "manhole_566_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387920.137465380365029, 5859772.67713953461498 ] } }, -{ "type": "Feature", "properties": { "_index": 565, "bedlevel": 895.29998779296875, "branchid": "pipe_32_E27;pipe_32_E28", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_567_generated", "shape": null, "area": 0.64, "streetlevel": 898.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 898.29998779296875, "distance_right": 4.516857479022367e-07, "index_right": 574, "nodeid": "1387937.420445_5859819.137726", "id": "1387937.420445_5859819.137726", "name": "manhole_567_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387937.420445227529854, 5859819.137726389802992 ] } }, -{ "type": "Feature", "properties": { "_index": 566, "bedlevel": 895.29998779296875, "branchid": "pipe_32_E28;pipe_32_E29", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_568_generated", "shape": null, "area": 0.64, "streetlevel": 898.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 898.29998779296875, "distance_right": 3.8531895841013795e-07, "index_right": 575, "nodeid": "1387948.863531_5859867.082766", "id": "1387948.863531_5859867.082766", "name": "manhole_568_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387948.863530882401392, 5859867.082766367122531 ] } }, -{ "type": "Feature", "properties": { "_index": 567, "bedlevel": 915.5, "branchid": "pipe_32_E29;pipe_32_E30", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_569_generated", "shape": null, "area": 0.64, "streetlevel": 918.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 918.5, "distance_right": 7.5942774747301615e-08, "index_right": 576, "nodeid": "1387950.013254_5859916.565450", "id": "1387950.013254_5859916.565450", "name": "manhole_569_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387950.013254075078294, 5859916.565449987538159 ] } }, -{ "type": "Feature", "properties": { "_index": 568, "bedlevel": 915.5, "branchid": "pipe_32_E30;pipe_32_E31", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_570_generated", "shape": null, "area": 0.64, "streetlevel": 918.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 918.5, "distance_right": 4.0775453204516037e-07, "index_right": 577, "nodeid": "1387947.430783_5859966.047936", "id": "1387947.430783_5859966.047936", "name": "manhole_570_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387947.430782878771424, 5859966.047936389222741 ] } }, -{ "type": "Feature", "properties": { "_index": 569, "bedlevel": 915.5, "branchid": "pipe_32_E31;pipe_32_E32", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_571_generated", "shape": null, "area": 0.64, "streetlevel": 918.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 918.5, "distance_right": 2.8747268719335361e-07, "index_right": 578, "nodeid": "1387943.997958_5860015.499966", "id": "1387943.997958_5860015.499966", "name": "manhole_571_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387943.997958281077445, 5860015.499966060742736 ] } }, -{ "type": "Feature", "properties": { "_index": 570, "bedlevel": 945.60003662109375, "branchid": "pipe_32_E32;pipe_32_E33", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_572_generated", "shape": null, "area": 0.64, "streetlevel": 948.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 948.60003662109375, "distance_right": 4.1395802122621752e-07, "index_right": 579, "nodeid": "1387940.565134_5860064.951996", "id": "1387940.565134_5860064.951996", "name": "manhole_572_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387940.565133683150634, 5860064.951995733194053 ] } }, -{ "type": "Feature", "properties": { "_index": 571, "bedlevel": 945.60003662109375, "branchid": "pipe_32_E33;pipe_32_E34", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_573_generated", "shape": null, "area": 0.64, "streetlevel": 948.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 948.60003662109375, "distance_right": 5.9329268490131064e-07, "index_right": 580, "nodeid": "1387945.371778_5860113.959105", "id": "1387945.371778_5860113.959105", "name": "manhole_573_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387945.371777657186612, 5860113.959104515612125 ] } }, -{ "type": "Feature", "properties": { "_index": 572, "bedlevel": 945.60003662109375, "branchid": "pipe_32_E34;pipe_32_E35", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_574_generated", "shape": null, "area": 0.64, "streetlevel": 948.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 948.60003662109375, "distance_right": 7.0201338766485011e-07, "index_right": 581, "nodeid": "1387964.117816_5860159.736532", "id": "1387964.117816_5860159.736532", "name": "manhole_574_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387964.117816498270258, 5860159.736532494425774 ] } }, -{ "type": "Feature", "properties": { "_index": 573, "bedlevel": 937.5, "branchid": "pipe_32_E35;pipe_32_E36", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_575_generated", "shape": null, "area": 0.64, "streetlevel": 940.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 940.5, "distance_right": 2.2971831659588874e-07, "index_right": 582, "nodeid": "1387984.093858_5860205.104421", "id": "1387984.093858_5860205.104421", "name": "manhole_575_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387984.093857799191028, 5860205.104420888237655 ] } }, -{ "type": "Feature", "properties": { "_index": 574, "bedlevel": 937.5, "branchid": "pipe_32_E36;pipe_32_E37", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_576_generated", "shape": null, "area": 0.64, "streetlevel": 940.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 940.5, "distance_right": 2.9934678285276023e-07, "index_right": 583, "nodeid": "1388004.069899_5860250.472309", "id": "1388004.069899_5860250.472309", "name": "manhole_576_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388004.069899099878967, 5860250.472309282049537 ] } }, -{ "type": "Feature", "properties": { "_index": 575, "bedlevel": 937.5, "branchid": "pipe_32_E37;pipe_32_E38", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_577_generated", "shape": null, "area": 0.64, "streetlevel": 940.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 940.5, "distance_right": 3.961540705670488e-07, "index_right": 584, "nodeid": "1388027.686926_5860293.896034", "id": "1388027.686926_5860293.896034", "name": "manhole_577_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388027.68692572391592, 5860293.896034284494817 ] } }, -{ "type": "Feature", "properties": { "_index": 576, "bedlevel": 968.70001220703125, "branchid": "pipe_32_E38;pipe_32_E39", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_578_generated", "shape": null, "area": 0.64, "streetlevel": 971.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 971.70001220703125, "distance_right": 4.1731728271541691e-07, "index_right": 585, "nodeid": "1388060.096316_5860331.348726", "id": "1388060.096316_5860331.348726", "name": "manhole_578_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388060.096315970877185, 5860331.348726416006684 ] } }, -{ "type": "Feature", "properties": { "_index": 577, "bedlevel": 932.5, "branchid": "pipe_32_E39;pipe_32_E40", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_579_generated", "shape": null, "area": 0.64, "streetlevel": 935.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 935.5, "distance_right": 3.2982661108630707e-07, "index_right": 586, "nodeid": "1388092.967689_5860368.453448", "id": "1388092.967689_5860368.453448", "name": "manhole_579_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388092.967688721138984, 5860368.453448176383972 ] } }, -{ "type": "Feature", "properties": { "_index": 578, "bedlevel": 932.5, "branchid": "pipe_32_E40;pipe_32_E41", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_580_generated", "shape": null, "area": 0.64, "streetlevel": 935.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 935.5, "distance_right": 2.9233183103705959e-07, "index_right": 587, "nodeid": "1388119.020827_5860410.510252", "id": "1388119.020827_5860410.510252", "name": "manhole_580_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388119.020827289205045, 5860410.510251956991851 ] } }, -{ "type": "Feature", "properties": { "_index": 579, "bedlevel": 946.9000244140625, "branchid": "pipe_32_E41;pipe_32_E42", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_581_generated", "shape": null, "area": 0.64, "streetlevel": 949.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 949.9000244140625, "distance_right": 2.622579606939989e-07, "index_right": 588, "nodeid": "1388143.407623_5860453.667774", "id": "1388143.407623_5860453.667774", "name": "manhole_581_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388143.407622833969072, 5860453.667774203233421 ] } }, -{ "type": "Feature", "properties": { "_index": 580, "bedlevel": 921.60003662109375, "branchid": "pipe_32_E42;pipe_32_E43", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_582_generated", "shape": null, "area": 0.64, "streetlevel": 924.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 924.60003662109375, "distance_right": 5.8808766619105842e-07, "index_right": 589, "nodeid": "1388167.794418_5860496.825296", "id": "1388167.794418_5860496.825296", "name": "manhole_582_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388167.794418378733099, 5860496.82529644947499 ] } }, -{ "type": "Feature", "properties": { "_index": 581, "bedlevel": 921.60003662109375, "branchid": "pipe_32_E43;pipe_32_E44", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_583_generated", "shape": null, "area": 0.64, "streetlevel": 924.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 924.60003662109375, "distance_right": 4.62331076853642e-07, "index_right": 590, "nodeid": "1388187.411865_5860542.097805", "id": "1388187.411865_5860542.097805", "name": "manhole_583_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388187.41186453984119, 5860542.097804954275489 ] } }, -{ "type": "Feature", "properties": { "_index": 582, "bedlevel": 939.4000244140625, "branchid": "pipe_32_E44;pipe_32_E45", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_584_generated", "shape": null, "area": 0.64, "streetlevel": 942.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 942.4000244140625, "distance_right": 4.0785502827304659e-07, "index_right": 591, "nodeid": "1388193.385166_5860591.251542", "id": "1388193.385166_5860591.251542", "name": "manhole_584_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388193.385166377527639, 5860591.251542154699564 ] } }, -{ "type": "Feature", "properties": { "_index": 583, "bedlevel": 939.4000244140625, "branchid": "pipe_32_E45;pipe_32_E46", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_585_generated", "shape": null, "area": 0.64, "streetlevel": 942.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 942.4000244140625, "distance_right": 5.4027566975976428e-07, "index_right": 592, "nodeid": "1388198.812296_5860640.524595", "id": "1388198.812296_5860640.524595", "name": "manhole_585_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388198.812296225922182, 5860640.524595490656793 ] } }, -{ "type": "Feature", "properties": { "_index": 584, "bedlevel": 939.4000244140625, "branchid": "pipe_32_E46;pipe_32_E47", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_586_generated", "shape": null, "area": 0.64, "streetlevel": 942.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 942.4000244140625, "distance_right": 1.8942515075575965e-07, "index_right": 593, "nodeid": "1388204.239426_5860689.797649", "id": "1388204.239426_5860689.797649", "name": "manhole_586_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388204.239426074549556, 5860689.7976488256827 ] } }, -{ "type": "Feature", "properties": { "_index": 585, "bedlevel": 952.0, "branchid": "pipe_32_E47;pipe_32_E48", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_587_generated", "shape": null, "area": 0.64, "streetlevel": 955.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 955.0, "distance_right": 4.7329980236488121e-07, "index_right": 594, "nodeid": "1388184.484932_5860730.700382", "id": "1388184.484932_5860730.700382", "name": "manhole_587_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388184.484932377934456, 5860730.700381714850664 ] } }, -{ "type": "Feature", "properties": { "_index": 586, "bedlevel": 952.0, "branchid": "pipe_32_E48;pipe_32_E49", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_588_generated", "shape": null, "area": 0.64, "streetlevel": 955.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 955.0, "distance_right": 3.139676122188116e-07, "index_right": 595, "nodeid": "1388159.550175_5860759.392760", "id": "1388159.550175_5860759.392760", "name": "manhole_588_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388159.550175313837826, 5860759.392759991809726 ] } }, -{ "type": "Feature", "properties": { "_index": 587, "bedlevel": 952.0, "branchid": "pipe_32_E49;pipe_32_E50", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_589_generated", "shape": null, "area": 0.64, "streetlevel": 955.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 955.0, "distance_right": 4.7230733375433857e-07, "index_right": 596, "nodeid": "1388171.988545_5860807.377909", "id": "1388171.988545_5860807.377909", "name": "manhole_589_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388171.988544700434431, 5860807.377908634953201 ] } }, -{ "type": "Feature", "properties": { "_index": 588, "bedlevel": 952.0, "branchid": "pipe_32_E50;pipe_32_E51", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_590_generated", "shape": null, "area": 0.64, "streetlevel": 955.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 955.0, "distance_right": 3.1729683108018581e-07, "index_right": 597, "nodeid": "1388215.013826_5860825.214943", "id": "1388215.013826_5860825.214943", "name": "manhole_590_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388215.013825689908117, 5860825.214942933060229 ] } }, -{ "type": "Feature", "properties": { "_index": 589, "bedlevel": 938.10003662109375, "branchid": "pipe_32_E51;pipe_32_E52", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_591_generated", "shape": null, "area": 0.64, "streetlevel": 941.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 941.10003662109375, "distance_right": 4.5798497811612042e-07, "index_right": 598, "nodeid": "1388264.397385_5860829.298033", "id": "1388264.397385_5860829.298033", "name": "manhole_591_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388264.397385431453586, 5860829.298032846301794 ] } }, -{ "type": "Feature", "properties": { "_index": 590, "bedlevel": 938.10003662109375, "branchid": "pipe_32_E52;pipe_32_E53", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_592_generated", "shape": null, "area": 0.64, "streetlevel": 941.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 941.10003662109375, "distance_right": 1.4876766767999893e-07, "index_right": 599, "nodeid": "1388313.062300_5860837.304879", "id": "1388313.062300_5860837.304879", "name": "manhole_592_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388313.062299854354933, 5860837.304878970608115 ] } }, -{ "type": "Feature", "properties": { "_index": 591, "bedlevel": 934.5, "branchid": "pipe_32_E53;pipe_32_E54", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_593_generated", "shape": null, "area": 0.64, "streetlevel": 937.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 937.5, "distance_right": 4.0248930382691132e-07, "index_right": 600, "nodeid": "1388360.993895_5860849.948046", "id": "1388360.993895_5860849.948046", "name": "manhole_593_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388360.993895401246846, 5860849.948045967146754 ] } }, -{ "type": "Feature", "properties": { "_index": 592, "bedlevel": 934.5, "branchid": "pipe_32_E54;pipe_32_E55", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_594_generated", "shape": null, "area": 0.64, "streetlevel": 937.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 937.5, "distance_right": 6.3027904613646236e-08, "index_right": 601, "nodeid": "1388408.925491_5860862.591213", "id": "1388408.925491_5860862.591213", "name": "manhole_594_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388408.925490947905928, 5860862.591212964616716 ] } }, -{ "type": "Feature", "properties": { "_index": 593, "bedlevel": 934.60003662109375, "branchid": "pipe_32_E55;pipe_32_E56", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_595_generated", "shape": null, "area": 0.64, "streetlevel": 937.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 937.60003662109375, "distance_right": 3.2074430373907896e-07, "index_right": 602, "nodeid": "1388458.220990_5860866.957202", "id": "1388458.220990_5860866.957202", "name": "manhole_595_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388458.220990223577246, 5860866.957201769575477 ] } }, -{ "type": "Feature", "properties": { "_index": 594, "bedlevel": 934.60003662109375, "branchid": "pipe_32_E56;pipe_32_E57", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_596_generated", "shape": null, "area": 0.64, "streetlevel": 937.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 937.60003662109375, "distance_right": 9.4677368422183038e-08, "index_right": 603, "nodeid": "1388507.336333_5860873.218385", "id": "1388507.336333_5860873.218385", "name": "manhole_596_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388507.336333080893382, 5860873.218384950421751 ] } }, -{ "type": "Feature", "properties": { "_index": 595, "bedlevel": 938.20001220703125, "branchid": "pipe_32_E57;pipe_32_E58", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_597_generated", "shape": null, "area": 0.64, "streetlevel": 941.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 941.20001220703125, "distance_right": 1.7964449623010729e-07, "index_right": 604, "nodeid": "1388556.215695_5860881.470384", "id": "1388556.215695_5860881.470384", "name": "manhole_597_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388556.215695114107803, 5860881.470384138636291 ] } }, -{ "type": "Feature", "properties": { "_index": 596, "bedlevel": 938.20001220703125, "branchid": "pipe_32_E58;pipe_32_E59", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_598_generated", "shape": null, "area": 0.64, "streetlevel": 941.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 941.20001220703125, "distance_right": 1.6011233671525675e-07, "index_right": 605, "nodeid": "1388604.556662_5860892.361969", "id": "1388604.556662_5860892.361969", "name": "manhole_598_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388604.556662159739062, 5860892.361969010904431 ] } }, -{ "type": "Feature", "properties": { "_index": 597, "bedlevel": 940.10003662109375, "branchid": "pipe_32_E59;pipe_32_E60", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_599_generated", "shape": null, "area": 0.64, "streetlevel": 943.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 943.10003662109375, "distance_right": 3.6964422062035383e-07, "index_right": 606, "nodeid": "1388653.599403_5860897.157898", "id": "1388653.599403_5860897.157898", "name": "manhole_599_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388653.59940263046883, 5860897.15789801068604 ] } }, -{ "type": "Feature", "properties": { "_index": 598, "bedlevel": 940.10003662109375, "branchid": "pipe_32_E60;pipe_32_E61", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_600_generated", "shape": null, "area": 0.64, "streetlevel": 943.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 943.10003662109375, "distance_right": 2.0861885525397415e-07, "index_right": 607, "nodeid": "1388700.080393_5860881.090511", "id": "1388700.080393_5860881.090511", "name": "manhole_600_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388700.080393208190799, 5860881.090511013753712 ] } }, -{ "type": "Feature", "properties": { "_index": 599, "bedlevel": 943.10003662109375, "branchid": "pipe_32_E61;pipe_32_E62", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_601_generated", "shape": null, "area": 0.64, "streetlevel": 946.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 946.10003662109375, "distance_right": 3.9818478577045887e-07, "index_right": 608, "nodeid": "1388732.687004_5860844.794781", "id": "1388732.687004_5860844.794781", "name": "manhole_601_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388732.687003659084439, 5860844.794781206175685 ] } }, -{ "type": "Feature", "properties": { "_index": 600, "bedlevel": 949.60003662109375, "branchid": "pipe_32_E62;pipe_32_E63", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_602_generated", "shape": null, "area": 0.64, "streetlevel": 952.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 952.60003662109375, "distance_right": 4.6036082438879739e-07, "index_right": 609, "nodeid": "1388755.953327_5860801.023036", "id": "1388755.953327_5860801.023036", "name": "manhole_602_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388755.953327334951609, 5860801.023035684600472 ] } }, -{ "type": "Feature", "properties": { "_index": 601, "bedlevel": 949.60003662109375, "branchid": "pipe_32_E63;pipe_32_E64", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_603_generated", "shape": null, "area": 0.64, "streetlevel": 952.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 952.60003662109375, "distance_right": 3.1337664014648673e-07, "index_right": 610, "nodeid": "1388778.233699_5860756.840240", "id": "1388778.233699_5860756.840240", "name": "manhole_603_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388778.23369869007729, 5860756.84024004638195 ] } }, -{ "type": "Feature", "properties": { "_index": 602, "bedlevel": 949.60003662109375, "branchid": "pipe_32_E64;pipe_32_E65", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_604_generated", "shape": null, "area": 0.64, "streetlevel": 952.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 952.60003662109375, "distance_right": 4.2335884748059321e-07, "index_right": 611, "nodeid": "1388792.950794_5860709.504264", "id": "1388792.950794_5860709.504264", "name": "manhole_604_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388792.950793598080054, 5860709.504263866692781 ] } }, -{ "type": "Feature", "properties": { "_index": 603, "bedlevel": 950.79998779296875, "branchid": "pipe_32_E65;pipe_32_E66", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_605_generated", "shape": null, "area": 0.64, "streetlevel": 953.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 953.79998779296875, "distance_right": 5.8393628355043254e-07, "index_right": 612, "nodeid": "1388807.667889_5860662.168288", "id": "1388807.667889_5860662.168288", "name": "manhole_605_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388807.667888506315649, 5860662.168287687934935 ] } }, -{ "type": "Feature", "properties": { "_index": 604, "bedlevel": 950.79998779296875, "branchid": "pipe_32_E66;pipe_32_E67", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_606_generated", "shape": null, "area": 0.64, "streetlevel": 953.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 953.79998779296875, "distance_right": 4.2307634411646621e-07, "index_right": 613, "nodeid": "1388819.224423_5860613.968191", "id": "1388819.224423_5860613.968191", "name": "manhole_606_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388819.224422588944435, 5860613.968191100284457 ] } }, -{ "type": "Feature", "properties": { "_index": 605, "bedlevel": 952.70001220703125, "branchid": "pipe_32_E67;pipe_32_E68", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_607_generated", "shape": null, "area": 0.64, "streetlevel": 955.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 955.70001220703125, "distance_right": 3.2847915211358398e-07, "index_right": 614, "nodeid": "1388830.638255_5860565.729079", "id": "1388830.638255_5860565.729079", "name": "manhole_607_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388830.63825476472266, 5860565.72907877061516 ] } }, -{ "type": "Feature", "properties": { "_index": 606, "bedlevel": 952.70001220703125, "branchid": "pipe_32_E68;pipe_32_E69", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_608_generated", "shape": null, "area": 0.64, "streetlevel": 955.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 955.70001220703125, "distance_right": 4.4360684295309176e-07, "index_right": 615, "nodeid": "1388842.052087_5860517.489966", "id": "1388842.052087_5860517.489966", "name": "manhole_608_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388842.052086940500885, 5860517.489966440014541 ] } }, -{ "type": "Feature", "properties": { "_index": 607, "bedlevel": 952.70001220703125, "branchid": "pipe_32_E69;pipe_32_E70", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_609_generated", "shape": null, "area": 0.64, "streetlevel": 955.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 955.70001220703125, "distance_right": 2.9630697691100381e-07, "index_right": 616, "nodeid": "1388862.776240_5860472.578981", "id": "1388862.776240_5860472.578981", "name": "manhole_609_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388862.77624000934884, 5860472.578981296159327 ] } }, -{ "type": "Feature", "properties": { "_index": 608, "bedlevel": 961.70001220703125, "branchid": "pipe_32_E70;pipe_32_E71", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_610_generated", "shape": null, "area": 0.64, "streetlevel": 964.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 964.70001220703125, "distance_right": 4.1085287726334795e-07, "index_right": 617, "nodeid": "1388884.529400_5860428.035884", "id": "1388884.529400_5860428.035884", "name": "manhole_610_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388884.529400010826066, 5860428.03588358964771 ] } }, -{ "type": "Feature", "properties": { "_index": 609, "bedlevel": 948.29998779296875, "branchid": "pipe_32_E71;pipe_32_E72", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_611_generated", "shape": null, "area": 0.64, "streetlevel": 951.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 951.29998779296875, "distance_right": 1.9786385917489472e-07, "index_right": 618, "nodeid": "1388906.282638_5860383.492824", "id": "1388906.282638_5860383.492824", "name": "manhole_611_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388906.282637836178765, 5860383.492823889479041 ] } }, -{ "type": "Feature", "properties": { "_index": 610, "bedlevel": 948.29998779296875, "branchid": "pipe_32_E72;pipe_32_E73", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_612_generated", "shape": null, "area": 0.64, "streetlevel": 951.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 951.29998779296875, "distance_right": 4.5358570654776362e-07, "index_right": 619, "nodeid": "1388933.946376_5860342.419800", "id": "1388933.946376_5860342.419800", "name": "manhole_612_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388933.946375871310011, 5860342.419800435192883 ] } }, -{ "type": "Feature", "properties": { "_index": 611, "bedlevel": 948.29998779296875, "branchid": "pipe_32_E73", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_613_generated", "shape": null, "area": 0.64, "streetlevel": 951.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 951.29998779296875, "distance_right": 4.6166295054686266e-07, "index_right": 620, "nodeid": "1388962.240716_5860301.717001", "id": "1388962.240716_5860301.717001", "name": "manhole_613_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388962.240715913940221, 5860301.717001453973353 ] } }, -{ "type": "Feature", "properties": { "_index": 612, "bedlevel": 749.29998779296875, "branchid": "pipe_33_E0;pipe_33_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_614_generated", "shape": null, "area": 0.64, "streetlevel": 752.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 752.29998779296875, "distance_right": 2.1054701440998384e-07, "index_right": 621, "nodeid": "1386825.198348_5859175.156894", "id": "1386825.198348_5859175.156894", "name": "manhole_614_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386825.19834817154333, 5859175.156894122250378 ] } }, -{ "type": "Feature", "properties": { "_index": 613, "bedlevel": 749.29998779296875, "branchid": "pipe_33_E1;pipe_33_E2", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_615_generated", "shape": null, "area": 0.64, "streetlevel": 752.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 752.29998779296875, "distance_right": 4.0506811183797461e-07, "index_right": 622, "nodeid": "1386779.333999_5859189.448422", "id": "1386779.333999_5859189.448422", "name": "manhole_615_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386779.333999397465959, 5859189.44842192158103 ] } }, -{ "type": "Feature", "properties": { "_index": 614, "bedlevel": 735.0, "branchid": "pipe_33_E2;pipe_33_E3", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_616_generated", "shape": null, "area": 0.64, "streetlevel": 738.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 738.0, "distance_right": 1.877787440964567e-07, "index_right": 623, "nodeid": "1386733.445003_5859203.660137", "id": "1386733.445003_5859203.660137", "name": "manhole_616_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386733.445003136992455, 5859203.660136871039867 ] } }, -{ "type": "Feature", "properties": { "_index": 615, "bedlevel": 735.0, "branchid": "pipe_33_E3;pipe_33_E4", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_617_generated", "shape": null, "area": 0.64, "streetlevel": 738.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 738.0, "distance_right": 3.9505892377035587e-07, "index_right": 624, "nodeid": "1386687.508547_5859217.718168", "id": "1386687.508547_5859217.718168", "name": "manhole_617_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386687.508546756347641, 5859217.718167688697577 ] } }, -{ "type": "Feature", "properties": { "_index": 616, "bedlevel": 760.29998779296875, "branchid": "pipe_33_E4;pipe_33_E5", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_618_generated", "shape": null, "area": 0.64, "streetlevel": 763.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 763.29998779296875, "distance_right": 6.1948814050446903e-07, "index_right": 625, "nodeid": "1386641.572090_5859231.776199", "id": "1386641.572090_5859231.776199", "name": "manhole_618_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386641.572090375469998, 5859231.776198507286608 ] } }, -{ "type": "Feature", "properties": { "_index": 617, "bedlevel": 760.29998779296875, "branchid": "pipe_33_E5;pipe_33_E6", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_619_generated", "shape": null, "area": 0.64, "streetlevel": 763.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 763.29998779296875, "distance_right": 4.9064792164743079e-07, "index_right": 626, "nodeid": "1386595.451642_5859245.168246", "id": "1386595.451642_5859245.168246", "name": "manhole_619_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386595.451642262749374, 5859245.168246414512396 ] } }, -{ "type": "Feature", "properties": { "_index": 618, "bedlevel": 751.60003662109375, "branchid": "pipe_33_E6;pipe_33_E7", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_620_generated", "shape": null, "area": 0.64, "streetlevel": 754.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 754.60003662109375, "distance_right": 4.9788017268457425e-07, "index_right": 627, "nodeid": "1386548.813361_5859256.685926", "id": "1386548.813361_5859256.685926", "name": "manhole_620_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386548.813360751140863, 5859256.685926430858672 ] } }, -{ "type": "Feature", "properties": { "_index": 619, "bedlevel": 751.60003662109375, "branchid": "pipe_33_E7;pipe_33_E8", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_621_generated", "shape": null, "area": 0.64, "streetlevel": 754.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 754.60003662109375, "distance_right": 5.0718835757375619e-07, "index_right": 628, "nodeid": "1386502.175079_5859268.203606", "id": "1386502.175079_5859268.203606", "name": "manhole_621_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386502.175079239532351, 5859268.203606447204947 ] } }, -{ "type": "Feature", "properties": { "_index": 620, "bedlevel": 739.5, "branchid": "pipe_33_E8;pipe_33_E9", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_622_generated", "shape": null, "area": 0.64, "streetlevel": 742.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 742.5, "distance_right": 5.6665798568557784e-07, "index_right": 629, "nodeid": "1386455.354357_5859278.943274", "id": "1386455.354357_5859278.943274", "name": "manhole_622_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386455.354356503346935, 5859278.943273726850748 ] } }, -{ "type": "Feature", "properties": { "_index": 621, "bedlevel": 739.5, "branchid": "pipe_33_E9;pipe_33_E10", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_623_generated", "shape": null, "area": 0.64, "streetlevel": 742.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 742.5, "distance_right": 2.9406242988679527e-07, "index_right": 630, "nodeid": "1386408.879240_5859290.671230", "id": "1386408.879240_5859290.671230", "name": "manhole_623_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386408.879239794565365, 5859290.671229789964855 ] } }, -{ "type": "Feature", "properties": { "_index": 622, "bedlevel": 714.60003662109375, "branchid": "pipe_33_E10;pipe_33_E11", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_624_generated", "shape": null, "area": 0.64, "streetlevel": 717.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 717.60003662109375, "distance_right": 3.9547400298640946e-07, "index_right": 631, "nodeid": "1386364.691369_5859309.518466", "id": "1386364.691369_5859309.518466", "name": "manhole_624_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386364.691368696978316, 5859309.518465746194124 ] } }, -{ "type": "Feature", "properties": { "_index": 623, "bedlevel": 714.60003662109375, "branchid": "pipe_33_E11;pipe_33_E12", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_625_generated", "shape": null, "area": 0.64, "streetlevel": 717.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 717.60003662109375, "distance_right": 4.9993553902667797e-07, "index_right": 632, "nodeid": "1386320.503498_5859328.365702", "id": "1386320.503498_5859328.365702", "name": "manhole_625_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386320.503497599391267, 5859328.365701701492071 ] } }, -{ "type": "Feature", "properties": { "_index": 624, "bedlevel": 708.0, "branchid": "pipe_33_E12", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_626_generated", "shape": null, "area": 0.64, "streetlevel": 711.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 711.0, "distance_right": 3.577770704512787e-07, "index_right": 633, "nodeid": "1386273.173812_5859335.365460", "id": "1386273.173812_5859335.365460", "name": "manhole_626_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386273.173811787506565, 5859335.36546028777957 ] } }, -{ "type": "Feature", "properties": { "_index": 625, "bedlevel": 950.70001220703125, "branchid": "pipe_34_E0;pipe_34_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_627_generated", "shape": null, "area": 0.64, "streetlevel": 953.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 953.70001220703125, "distance_right": 5.9695420529554627e-07, "index_right": 634, "nodeid": "1388922.246059_5860458.418739", "id": "1388922.246059_5860458.418739", "name": "manhole_627_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388922.246059404918924, 5860458.418739438988268 ] } }, -{ "type": "Feature", "properties": { "_index": 626, "bedlevel": 950.70001220703125, "branchid": "pipe_34_E1;pipe_34_E2", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_628_generated", "shape": null, "area": 0.64, "streetlevel": 953.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 953.70001220703125, "distance_right": 2.1646990066709852e-08, "index_right": 635, "nodeid": "1388900.295978_5860503.075898", "id": "1388900.295978_5860503.075898", "name": "manhole_628_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388900.295977992936969, 5860503.075897979550064 ] } }, -{ "type": "Feature", "properties": { "_index": 627, "bedlevel": 952.70001220703125, "branchid": "pipe_34_E2;pipe_34_E3", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_629_generated", "shape": null, "area": 0.64, "streetlevel": 955.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 955.70001220703125, "distance_right": 6.3678227575811753e-07, "index_right": 636, "nodeid": "1388878.345897_5860547.733057", "id": "1388878.345897_5860547.733057", "name": "manhole_629_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388878.345896581187844, 5860547.733056520111859 ] } }, -{ "type": "Feature", "properties": { "_index": 628, "bedlevel": 950.79998779296875, "branchid": "pipe_34_E3;pipe_34_E4", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_630_generated", "shape": null, "area": 0.64, "streetlevel": 953.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 953.79998779296875, "distance_right": 6.8182421614991291e-07, "index_right": 637, "nodeid": "1388856.887740_5860592.570928", "id": "1388856.887740_5860592.570928", "name": "manhole_630_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388856.887740465346724, 5860592.570927501656115 ] } }, -{ "type": "Feature", "properties": { "_index": 629, "bedlevel": 950.79998779296875, "branchid": "pipe_34_E4;pipe_34_E5", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_631_generated", "shape": null, "area": 0.64, "streetlevel": 953.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 953.79998779296875, "distance_right": 2.7419275813984667e-07, "index_right": 638, "nodeid": "1388853.076020_5860641.795407", "id": "1388853.076020_5860641.795407", "name": "manhole_631_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388853.076019846601412, 5860641.795407227240503 ] } }, -{ "type": "Feature", "properties": { "_index": 630, "bedlevel": 950.79998779296875, "branchid": "pipe_34_E5;pipe_34_E6", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_632_generated", "shape": null, "area": 0.64, "streetlevel": 953.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 953.79998779296875, "distance_right": 8.3497951232706373e-08, "index_right": 639, "nodeid": "1388856.119827_5860691.462329", "id": "1388856.119827_5860691.462329", "name": "manhole_632_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388856.119826921960339, 5860691.462329030036926 ] } }, -{ "type": "Feature", "properties": { "_index": 631, "bedlevel": 949.5, "branchid": "pipe_34_E6;pipe_34_E7", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_633_generated", "shape": null, "area": 0.64, "streetlevel": 952.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 952.5, "distance_right": 1.667342165101211e-07, "index_right": 640, "nodeid": "1388859.163634_5860741.129251", "id": "1388859.163634_5860741.129251", "name": "manhole_633_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388859.163633997086436, 5860741.12925083283335 ] } }, -{ "type": "Feature", "properties": { "_index": 632, "bedlevel": 949.5, "branchid": "pipe_34_E7;pipe_34_E8", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_634_generated", "shape": null, "area": 0.64, "streetlevel": 952.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 952.5, "distance_right": 3.7127669706251919e-07, "index_right": 641, "nodeid": "1388862.207441_5860790.796173", "id": "1388862.207441_5860790.796173", "name": "manhole_634_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388862.207441072445363, 5860790.796172635629773 ] } }, -{ "type": "Feature", "properties": { "_index": 633, "bedlevel": 942.5, "branchid": "pipe_34_E8;pipe_34_E9", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_635_generated", "shape": null, "area": 0.64, "streetlevel": 945.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 945.5, "distance_right": 2.0225358905841224e-07, "index_right": 642, "nodeid": "1388866.356326_5860840.344227", "id": "1388866.356326_5860840.344227", "name": "manhole_635_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388866.356326055014506, 5860840.344227194786072 ] } }, -{ "type": "Feature", "properties": { "_index": 634, "bedlevel": 942.5, "branchid": "pipe_34_E9;pipe_34_E10", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_636_generated", "shape": null, "area": 0.64, "streetlevel": 945.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 945.5, "distance_right": 3.8925384345881058e-07, "index_right": 643, "nodeid": "1388873.944741_5860889.522310", "id": "1388873.944741_5860889.522310", "name": "manhole_636_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388873.944740658160299, 5860889.522310186177492 ] } }, -{ "type": "Feature", "properties": { "_index": 635, "bedlevel": 942.5, "branchid": "pipe_34_E10;pipe_34_E11", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_637_generated", "shape": null, "area": 0.64, "streetlevel": 945.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 945.5, "distance_right": 3.0329102696444249e-07, "index_right": 644, "nodeid": "1388883.174273_5860938.398467", "id": "1388883.174273_5860938.398467", "name": "manhole_637_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388883.17427325528115, 5860938.398467163555324 ] } }, -{ "type": "Feature", "properties": { "_index": 636, "bedlevel": 934.4000244140625, "branchid": "pipe_34_E11;pipe_34_E12", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_638_generated", "shape": null, "area": 0.64, "streetlevel": 937.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 937.4000244140625, "distance_right": 1.6802195612188359e-07, "index_right": 645, "nodeid": "1388890.216841_5860987.212369", "id": "1388890.216841_5860987.212369", "name": "manhole_638_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388890.216840920504183, 5860987.212368851527572 ] } }, -{ "type": "Feature", "properties": { "_index": 637, "bedlevel": 934.4000244140625, "branchid": "pipe_34_E12;pipe_34_E13", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_639_generated", "shape": null, "area": 0.64, "streetlevel": 937.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 937.4000244140625, "distance_right": 1.1231997364245297e-07, "index_right": 646, "nodeid": "1388884.322195_5861036.622095", "id": "1388884.322195_5861036.622095", "name": "manhole_639_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388884.322194910608232, 5861036.62209493201226 ] } }, -{ "type": "Feature", "properties": { "_index": 638, "bedlevel": 934.4000244140625, "branchid": "pipe_34_E13;pipe_34_E14", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_640_generated", "shape": null, "area": 0.64, "streetlevel": 937.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 937.4000244140625, "distance_right": 9.9813494894073822e-08, "index_right": 647, "nodeid": "1388878.427549_5861086.031821", "id": "1388878.427549_5861086.031821", "name": "manhole_640_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388878.427548900712281, 5861086.031821011565626 ] } }, -{ "type": "Feature", "properties": { "_index": 639, "bedlevel": 927.4000244140625, "branchid": "pipe_34_E14;pipe_34_E15", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_641_generated", "shape": null, "area": 0.64, "streetlevel": 930.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 930.4000244140625, "distance_right": 1.4291648644270733e-07, "index_right": 648, "nodeid": "1388872.532903_5861135.441547", "id": "1388872.532903_5861135.441547", "name": "manhole_641_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388872.532902890816331, 5861135.441547092050314 ] } }, -{ "type": "Feature", "properties": { "_index": 640, "bedlevel": 927.4000244140625, "branchid": "pipe_34_E15;pipe_34_E16", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_642_generated", "shape": null, "area": 0.64, "streetlevel": 930.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 930.4000244140625, "distance_right": 2.093820748219209e-07, "index_right": 649, "nodeid": "1388866.638257_5861184.851273", "id": "1388866.638257_5861184.851273", "name": "manhole_642_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388866.63825688092038, 5861184.851273172535002 ] } }, -{ "type": "Feature", "properties": { "_index": 641, "bedlevel": 927.4000244140625, "branchid": "pipe_34_E16;pipe_34_E17", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_643_generated", "shape": null, "area": 0.64, "streetlevel": 930.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 930.4000244140625, "distance_right": 3.9648214779219621e-07, "index_right": 650, "nodeid": "1388854.620841_5861232.489913", "id": "1388854.620841_5861232.489913", "name": "manhole_643_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388854.620840607210994, 5861232.489912945777178 ] } }, -{ "type": "Feature", "properties": { "_index": 642, "bedlevel": 923.60003662109375, "branchid": "pipe_34_E17;pipe_34_E18", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_644_generated", "shape": null, "area": 0.64, "streetlevel": 926.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 926.60003662109375, "distance_right": 4.931566840797132e-07, "index_right": 651, "nodeid": "1388833.227561_5861277.416469", "id": "1388833.227561_5861277.416469", "name": "manhole_644_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388833.22756120422855, 5861277.416469449177384 ] } }, -{ "type": "Feature", "properties": { "_index": 643, "bedlevel": 923.60003662109375, "branchid": "pipe_34_E18;pipe_34_E19", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_645_generated", "shape": null, "area": 0.64, "streetlevel": 926.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 926.60003662109375, "distance_right": 2.0421729585515747e-07, "index_right": 652, "nodeid": "1388811.834282_5861322.343026", "id": "1388811.834282_5861322.343026", "name": "manhole_645_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388811.834281801246107, 5861322.343025953508914 ] } }, -{ "type": "Feature", "properties": { "_index": 644, "bedlevel": 928.10003662109375, "branchid": "pipe_34_E19;pipe_34_E20", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_646_generated", "shape": null, "area": 0.64, "streetlevel": 931.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 931.10003662109375, "distance_right": 6.0631692520020048e-07, "index_right": 653, "nodeid": "1388790.441002_5861367.269582", "id": "1388790.441002_5861367.269582", "name": "manhole_646_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388790.441002398030832, 5861367.26958245690912 ] } }, -{ "type": "Feature", "properties": { "_index": 645, "bedlevel": 919.20001220703125, "branchid": "pipe_34_E20;pipe_34_E21", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_647_generated", "shape": null, "area": 0.64, "streetlevel": 922.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 922.20001220703125, "distance_right": 4.0344250041906387e-08, "index_right": 654, "nodeid": "1388769.047723_5861412.196139", "id": "1388769.047723_5861412.196139", "name": "manhole_647_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388769.047722995048389, 5861412.196138960309327 ] } }, -{ "type": "Feature", "properties": { "_index": 646, "bedlevel": 919.20001220703125, "branchid": "pipe_34_E21;pipe_34_E22", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_648_generated", "shape": null, "area": 0.64, "streetlevel": 922.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 922.20001220703125, "distance_right": 6.1836242235722718e-07, "index_right": 655, "nodeid": "1388747.654444_5861457.122695", "id": "1388747.654444_5861457.122695", "name": "manhole_648_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388747.654443592065945, 5861457.122695464640856 ] } }, -{ "type": "Feature", "properties": { "_index": 647, "bedlevel": 919.20001220703125, "branchid": "pipe_34_E22;pipe_34_E23", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_649_generated", "shape": null, "area": 0.64, "streetlevel": 922.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 922.20001220703125, "distance_right": 4.2697769327700622e-07, "index_right": 656, "nodeid": "1388725.026127_5861501.410492", "id": "1388725.026127_5861501.410492", "name": "manhole_649_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388725.026126575190574, 5861501.410491958260536 ] } }, -{ "type": "Feature", "properties": { "_index": 648, "bedlevel": 897.20001220703125, "branchid": "pipe_34_E23;pipe_34_E24", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_650_generated", "shape": null, "area": 0.64, "streetlevel": 900.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 900.20001220703125, "distance_right": 3.8289478952932213e-07, "index_right": 657, "nodeid": "1388700.725248_5861544.833242", "id": "1388700.725248_5861544.833242", "name": "manhole_650_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388700.725248141447082, 5861544.833241644315422 ] } }, -{ "type": "Feature", "properties": { "_index": 649, "bedlevel": 897.20001220703125, "branchid": "pipe_34_E24;pipe_34_E25", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_651_generated", "shape": null, "area": 0.64, "streetlevel": 900.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 900.20001220703125, "distance_right": 4.4054123517975461e-07, "index_right": 658, "nodeid": "1388676.424370_5861588.255991", "id": "1388676.424370_5861588.255991", "name": "manhole_651_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388676.42436970770359, 5861588.255991329438984 ] } }, -{ "type": "Feature", "properties": { "_index": 650, "bedlevel": 897.20001220703125, "branchid": "pipe_34_E25;pipe_34_E26", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_652_generated", "shape": null, "area": 0.64, "streetlevel": 900.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 900.20001220703125, "distance_right": 3.923347648023898e-07, "index_right": 659, "nodeid": "1388632.324465_5861606.441272", "id": "1388632.324465_5861606.441272", "name": "manhole_652_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388632.324464634526521, 5861606.441272142343223 ] } }, -{ "type": "Feature", "properties": { "_index": 651, "bedlevel": 895.4000244140625, "branchid": "pipe_34_E26;pipe_34_E27", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_653_generated", "shape": null, "area": 0.64, "streetlevel": 898.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 898.4000244140625, "distance_right": 5.2422671262703447e-07, "index_right": 660, "nodeid": "1388583.463808_5861611.105615", "id": "1388583.463808_5861611.105615", "name": "manhole_653_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388583.463808472501114, 5861611.105615227483213 ] } }, -{ "type": "Feature", "properties": { "_index": 652, "bedlevel": 895.4000244140625, "branchid": "pipe_34_E27;pipe_34_E28", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_654_generated", "shape": null, "area": 0.64, "streetlevel": 898.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 898.4000244140625, "distance_right": 1.7655441931671308e-07, "index_right": 661, "nodeid": "1388534.764013_5861604.222018", "id": "1388534.764013_5861604.222018", "name": "manhole_654_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388534.764012826373801, 5861604.222017968073487 ] } }, -{ "type": "Feature", "properties": { "_index": 653, "bedlevel": 900.60003662109375, "branchid": "pipe_34_E28;pipe_34_E29", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_655_generated", "shape": null, "area": 0.64, "streetlevel": 903.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 903.60003662109375, "distance_right": 1.267805079935303e-07, "index_right": 662, "nodeid": "1388489.566489_5861583.407318", "id": "1388489.566489_5861583.407318", "name": "manhole_655_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388489.566489090910181, 5861583.40731808822602 ] } }, -{ "type": "Feature", "properties": { "_index": 654, "bedlevel": 900.60003662109375, "branchid": "pipe_34_E29;pipe_34_E30", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_656_generated", "shape": null, "area": 0.64, "streetlevel": 903.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 903.60003662109375, "distance_right": 3.5366016764945169e-07, "index_right": 663, "nodeid": "1388444.204916_5861563.162508", "id": "1388444.204916_5861563.162508", "name": "manhole_656_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388444.204915680922568, 5861563.162508152425289 ] } }, -{ "type": "Feature", "properties": { "_index": 655, "bedlevel": 903.4000244140625, "branchid": "pipe_34_E30;pipe_34_E31", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_657_generated", "shape": null, "area": 0.64, "streetlevel": 906.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 906.4000244140625, "distance_right": 5.7176550681391025e-07, "index_right": 664, "nodeid": "1388394.858231_5861556.761521", "id": "1388394.858231_5861556.761521", "name": "manhole_657_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388394.858231473481283, 5861556.761520680040121 ] } }, -{ "type": "Feature", "properties": { "_index": 656, "bedlevel": 903.4000244140625, "branchid": "pipe_34_E31;pipe_34_E32", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_658_generated", "shape": null, "area": 0.64, "streetlevel": 906.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 906.4000244140625, "distance_right": 2.8018892283096598e-07, "index_right": 665, "nodeid": "1388350.680838_5861570.408674", "id": "1388350.680838_5861570.408674", "name": "manhole_658_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388350.680838279658929, 5861570.408674017526209 ] } }, -{ "type": "Feature", "properties": { "_index": 657, "bedlevel": 897.20001220703125, "branchid": "pipe_34_E32;pipe_34_E33", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_659_generated", "shape": null, "area": 0.64, "streetlevel": 900.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 900.20001220703125, "distance_right": 4.057703762092192e-07, "index_right": 666, "nodeid": "1388310.581733_5861599.872714", "id": "1388310.581733_5861599.872714", "name": "manhole_659_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388310.581732882419601, 5861599.872713611461222 ] } }, -{ "type": "Feature", "properties": { "_index": 658, "bedlevel": 897.20001220703125, "branchid": "pipe_34_E33;pipe_34_E34", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_660_generated", "shape": null, "area": 0.64, "streetlevel": 900.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 900.20001220703125, "distance_right": 5.5718800522406768e-07, "index_right": 667, "nodeid": "1388271.039626_5861629.969603", "id": "1388271.039626_5861629.969603", "name": "manhole_660_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388271.039625711739063, 5861629.969603477045894 ] } }, -{ "type": "Feature", "properties": { "_index": 659, "bedlevel": 887.0, "branchid": "pipe_34_E34;pipe_34_E35", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_661_generated", "shape": null, "area": 0.64, "streetlevel": 890.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 890.0, "distance_right": 3.3198253484132111e-07, "index_right": 668, "nodeid": "1388236.722210_5861666.002684", "id": "1388236.722210_5861666.002684", "name": "manhole_661_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388236.722210306907073, 5861666.002683873288333 ] } }, -{ "type": "Feature", "properties": { "_index": 660, "bedlevel": 887.0, "branchid": "pipe_34_E35;pipe_34_E36", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_662_generated", "shape": null, "area": 0.64, "streetlevel": 890.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 890.0, "distance_right": 2.8636616923067504e-07, "index_right": 669, "nodeid": "1388202.404795_5861702.035764", "id": "1388202.404795_5861702.035764", "name": "manhole_662_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388202.404794902307913, 5861702.035764269530773 ] } }, -{ "type": "Feature", "properties": { "_index": 661, "bedlevel": 887.0, "branchid": "pipe_34_E36;pipe_34_E37", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_663_generated", "shape": null, "area": 0.64, "streetlevel": 890.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 890.0, "distance_right": 5.9945933282054772e-07, "index_right": 670, "nodeid": "1388168.087379_5861738.068845", "id": "1388168.087379_5861738.068845", "name": "manhole_663_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388168.087379497475922, 5861738.068844665773213 ] } }, -{ "type": "Feature", "properties": { "_index": 662, "bedlevel": 882.9000244140625, "branchid": "pipe_34_E37;pipe_34_E38", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_664_generated", "shape": null, "area": 0.64, "streetlevel": 885.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 885.9000244140625, "distance_right": 1.1171698567518565e-07, "index_right": 671, "nodeid": "1388133.769964_5861774.101925", "id": "1388133.769964_5861774.101925", "name": "manhole_664_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388133.769964092643932, 5861774.101925062015653 ] } }, -{ "type": "Feature", "properties": { "_index": 663, "bedlevel": 871.0, "branchid": "pipe_34_E38;pipe_34_E39", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_665_generated", "shape": null, "area": 0.64, "streetlevel": 874.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 874.0, "distance_right": 5.5370519548127108e-07, "index_right": 672, "nodeid": "1388099.452549_5861810.135005", "id": "1388099.452549_5861810.135005", "name": "manhole_665_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388099.452548687811941, 5861810.13500545732677 ] } }, -{ "type": "Feature", "properties": { "_index": 664, "bedlevel": 871.0, "branchid": "pipe_34_E39;pipe_34_E40", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_666_generated", "shape": null, "area": 0.64, "streetlevel": 874.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 874.0, "distance_right": 3.1864981069759395e-07, "index_right": 673, "nodeid": "1388065.135133_5861846.168086", "id": "1388065.135133_5861846.168086", "name": "manhole_666_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388065.135133283212781, 5861846.16808585356921 ] } }, -{ "type": "Feature", "properties": { "_index": 665, "bedlevel": 859.20001220703125, "branchid": "pipe_34_E40;pipe_34_E41", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_667_generated", "shape": null, "area": 0.64, "streetlevel": 862.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 862.20001220703125, "distance_right": 3.6733334325308476e-07, "index_right": 674, "nodeid": "1388022.995197_5861866.899685", "id": "1388022.995197_5861866.899685", "name": "manhole_667_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388022.995196633273736, 5861866.899685021489859 ] } }, -{ "type": "Feature", "properties": { "_index": 666, "bedlevel": 859.20001220703125, "branchid": "pipe_34_E41;pipe_34_E42", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_668_generated", "shape": null, "area": 0.64, "streetlevel": 862.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 862.20001220703125, "distance_right": 5.3807499256072629e-07, "index_right": 675, "nodeid": "1387973.690500_5861873.616436", "id": "1387973.690500_5861873.616436", "name": "manhole_668_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387973.690499771386385, 5861873.616436487063766 ] } }, -{ "type": "Feature", "properties": { "_index": 667, "bedlevel": 856.20001220703125, "branchid": "pipe_34_E42;pipe_34_E43", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_669_generated", "shape": null, "area": 0.64, "streetlevel": 859.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 859.20001220703125, "distance_right": 5.474378737578715e-07, "index_right": 676, "nodeid": "1387924.470484_5861880.906597", "id": "1387924.470484_5861880.906597", "name": "manhole_669_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387924.470484273741022, 5861880.90659652557224 ] } }, -{ "type": "Feature", "properties": { "_index": 668, "bedlevel": 856.20001220703125, "branchid": "pipe_34_E43;pipe_34_E44", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_670_generated", "shape": null, "area": 0.64, "streetlevel": 859.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 859.20001220703125, "distance_right": 2.6713630888038328e-07, "index_right": 677, "nodeid": "1387877.962617_5861896.157046", "id": "1387877.962617_5861896.157046", "name": "manhole_670_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387877.962616891367361, 5861896.157046243548393 ] } }, -{ "type": "Feature", "properties": { "_index": 669, "bedlevel": 856.20001220703125, "branchid": "pipe_34_E44;pipe_34_E45", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_671_generated", "shape": null, "area": 0.64, "streetlevel": 859.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 859.20001220703125, "distance_right": 2.3805860219097484e-07, "index_right": 678, "nodeid": "1387917.070526_5861911.915830", "id": "1387917.070526_5861911.915830", "name": "manhole_671_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387917.070526217576116, 5861911.915829903446138 ] } }, -{ "type": "Feature", "properties": { "_index": 670, "bedlevel": 856.20001220703125, "branchid": "pipe_34_E45;pipe_34_E46", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_672_generated", "shape": null, "area": 0.64, "streetlevel": 859.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 859.20001220703125, "distance_right": 4.3134922908785989e-07, "index_right": 679, "nodeid": "1387966.654668_5861916.096835", "id": "1387966.654668_5861916.096835", "name": "manhole_672_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387966.654667611001059, 5861916.096835186704993 ] } }, -{ "type": "Feature", "properties": { "_index": 671, "bedlevel": 843.29998779296875, "branchid": "pipe_34_E46;pipe_34_E47", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_673_generated", "shape": null, "area": 0.64, "streetlevel": 846.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 846.29998779296875, "distance_right": 6.6910196134826447e-07, "index_right": 680, "nodeid": "1388016.318006_5861919.063731", "id": "1388016.318006_5861919.063731", "name": "manhole_673_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388016.318005530629307, 5861919.063731476664543 ] } }, -{ "type": "Feature", "properties": { "_index": 672, "bedlevel": 847.10003662109375, "branchid": "pipe_34_E47;pipe_34_E48", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_674_generated", "shape": null, "area": 0.64, "streetlevel": 850.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 850.10003662109375, "distance_right": 4.9533251570249879e-07, "index_right": 681, "nodeid": "1388066.025121_5861921.359511", "id": "1388066.025121_5861921.359511", "name": "manhole_674_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388066.025120510486886, 5861921.359510923735797 ] } }, -{ "type": "Feature", "properties": { "_index": 673, "bedlevel": 847.10003662109375, "branchid": "pipe_34_E48;pipe_34_E49", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_675_generated", "shape": null, "area": 0.64, "streetlevel": 850.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 850.10003662109375, "distance_right": 6.1467730890167978e-07, "index_right": 682, "nodeid": "1388115.732235_5861923.655290", "id": "1388115.732235_5861923.655290", "name": "manhole_675_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388115.732235490344465, 5861923.655290370807052 ] } }, -{ "type": "Feature", "properties": { "_index": 674, "bedlevel": 846.0, "branchid": "pipe_34_E49;pipe_34_E50", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_676_generated", "shape": null, "area": 0.64, "streetlevel": 849.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 849.0, "distance_right": 3.5555129936383504e-07, "index_right": 683, "nodeid": "1388161.130695_5861931.457672", "id": "1388161.130695_5861931.457672", "name": "manhole_676_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388161.130695321131498, 5861931.457672152668238 ] } }, -{ "type": "Feature", "properties": { "_index": 675, "bedlevel": 847.10003662109375, "branchid": "pipe_34_E50;pipe_34_E51", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_677_generated", "shape": null, "area": 0.64, "streetlevel": 850.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 850.10003662109375, "distance_right": 2.672133099130381e-07, "index_right": 684, "nodeid": "1388139.871224_5861964.082641", "id": "1388139.871224_5861964.082641", "name": "manhole_677_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388139.871223766123876, 5861964.082641129381955 ] } }, -{ "type": "Feature", "properties": { "_index": 676, "bedlevel": 847.10003662109375, "branchid": "pipe_34_E51;pipe_34_E52", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_678_generated", "shape": null, "area": 0.64, "streetlevel": 850.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 850.10003662109375, "distance_right": 3.921092014707088e-07, "index_right": 685, "nodeid": "1388090.726846_5861957.769498", "id": "1388090.726846_5861957.769498", "name": "manhole_678_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388090.726845995755866, 5861957.769498392008245 ] } }, -{ "type": "Feature", "properties": { "_index": 677, "bedlevel": 843.29998779296875, "branchid": "pipe_34_E52;pipe_34_E53", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_679_generated", "shape": null, "area": 0.64, "streetlevel": 846.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 846.29998779296875, "distance_right": 2.2779084516867197e-07, "index_right": 686, "nodeid": "1388049.339105_5861983.736727", "id": "1388049.339105_5861983.736727", "name": "manhole_679_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388049.339104855433106, 5861983.736727176234126 ] } }, -{ "type": "Feature", "properties": { "_index": 678, "bedlevel": 843.29998779296875, "branchid": "pipe_34_E53;pipe_34_E54", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_680_generated", "shape": null, "area": 0.64, "streetlevel": 846.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 846.29998779296875, "distance_right": 4.6927575053310853e-07, "index_right": 687, "nodeid": "1388024.713076_5862026.975906", "id": "1388024.713076_5862026.975906", "name": "manhole_680_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388024.713075590552762, 5862026.975905770435929 ] } }, -{ "type": "Feature", "properties": { "_index": 679, "bedlevel": 843.29998779296875, "branchid": "pipe_34_E54;pipe_34_E55", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_681_generated", "shape": null, "area": 0.64, "streetlevel": 846.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 846.29998779296875, "distance_right": 3.7928111851215363e-07, "index_right": 688, "nodeid": "1387980.016218_5862047.702198", "id": "1387980.016218_5862047.702198", "name": "manhole_681_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387980.016218039905652, 5862047.702198376879096 ] } }, -{ "type": "Feature", "properties": { "_index": 680, "bedlevel": 790.5, "branchid": "pipe_34_E55;pipe_34_E56", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_682_generated", "shape": null, "area": 0.64, "streetlevel": 793.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 793.5, "distance_right": 5.3642689716381333e-07, "index_right": 689, "nodeid": "1387931.906731_5862056.853297", "id": "1387931.906731_5862056.853297", "name": "manhole_682_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387931.90673128189519, 5862056.853296543471515 ] } }, -{ "type": "Feature", "properties": { "_index": 681, "bedlevel": 790.5, "branchid": "pipe_34_E56;pipe_34_E57", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_683_generated", "shape": null, "area": 0.64, "streetlevel": 793.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 793.5, "distance_right": 6.560974611428636e-07, "index_right": 690, "nodeid": "1387882.187313_5862058.865105", "id": "1387882.187313_5862058.865105", "name": "manhole_683_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387882.187313467729837, 5862058.865105460397899 ] } }, -{ "type": "Feature", "properties": { "_index": 682, "bedlevel": 790.20001220703125, "branchid": "pipe_34_E57;pipe_34_E58", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_684_generated", "shape": null, "area": 0.64, "streetlevel": 793.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 793.20001220703125, "distance_right": 3.4705732931458691e-07, "index_right": 691, "nodeid": "1387832.722497_5862057.341085", "id": "1387832.722497_5862057.341085", "name": "manhole_684_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387832.722497318405658, 5862057.3410848621279 ] } }, -{ "type": "Feature", "properties": { "_index": 683, "bedlevel": 827.29998779296875, "branchid": "pipe_34_E58;pipe_34_E59", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_685_generated", "shape": null, "area": 0.64, "streetlevel": 830.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 830.29998779296875, "distance_right": 3.9864767552081094e-07, "index_right": 692, "nodeid": "1387783.804231_5862048.226751", "id": "1387783.804231_5862048.226751", "name": "manhole_685_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387783.80423084856011, 5862048.226750630885363 ] } }, -{ "type": "Feature", "properties": { "_index": 684, "bedlevel": 814.70001220703125, "branchid": "pipe_34_E59;pipe_34_E60", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_686_generated", "shape": null, "area": 0.64, "streetlevel": 817.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 817.70001220703125, "distance_right": 5.5057358477645188e-07, "index_right": 693, "nodeid": "1387734.885964_5862039.112416", "id": "1387734.885964_5862039.112416", "name": "manhole_686_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387734.885964378714561, 5862039.112416399642825 ] } }, -{ "type": "Feature", "properties": { "_index": 685, "bedlevel": 810.70001220703125, "branchid": "pipe_34_E60;pipe_34_E61", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_687_generated", "shape": null, "area": 0.64, "streetlevel": 813.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 813.70001220703125, "distance_right": 1.9158114081199618e-07, "index_right": 694, "nodeid": "1387685.967698_5862029.998082", "id": "1387685.967698_5862029.998082", "name": "manhole_687_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387685.967697908869013, 5862029.998082168400288 ] } }, -{ "type": "Feature", "properties": { "_index": 686, "bedlevel": 810.70001220703125, "branchid": "pipe_34_E61;pipe_34_E62", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_688_generated", "shape": null, "area": 0.64, "streetlevel": 813.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 813.70001220703125, "distance_right": 4.5903439743479076e-07, "index_right": 695, "nodeid": "1387637.036116_5862020.957141", "id": "1387637.036116_5862020.957141", "name": "manhole_688_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387637.036115845199674, 5862020.957140567712486 ] } }, -{ "type": "Feature", "properties": { "_index": 687, "bedlevel": 804.0, "branchid": "pipe_34_E62;pipe_34_E63", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_689_generated", "shape": null, "area": 0.64, "streetlevel": 807.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.0, "distance_right": 4.9447928351944995e-07, "index_right": 696, "nodeid": "1387588.033850_5862012.305794", "id": "1387588.033850_5862012.305794", "name": "manhole_689_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387588.033849656581879, 5862012.305794355459511 ] } }, -{ "type": "Feature", "properties": { "_index": 688, "bedlevel": 804.0, "branchid": "pipe_34_E63;pipe_34_E64", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_690_generated", "shape": null, "area": 0.64, "streetlevel": 807.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.0, "distance_right": 4.8969642604152781e-07, "index_right": 697, "nodeid": "1387539.031583_5862003.654448", "id": "1387539.031583_5862003.654448", "name": "manhole_690_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387539.031583468196914, 5862003.654448143206537 ] } }, -{ "type": "Feature", "properties": { "_index": 689, "bedlevel": 790.10003662109375, "branchid": "pipe_34_E64;pipe_34_E65", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_691_generated", "shape": null, "area": 0.64, "streetlevel": 793.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 793.10003662109375, "distance_right": 2.8799720097075195e-07, "index_right": 698, "nodeid": "1387490.029317_5861995.003102", "id": "1387490.029317_5861995.003102", "name": "manhole_691_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387490.029317279579118, 5861995.003101930953562 ] } }, -{ "type": "Feature", "properties": { "_index": 690, "bedlevel": 790.10003662109375, "branchid": "pipe_34_E65;pipe_34_E66", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_692_generated", "shape": null, "area": 0.64, "streetlevel": 793.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 793.10003662109375, "distance_right": 3.8909253916758981e-07, "index_right": 699, "nodeid": "1387440.720368_5861989.908139", "id": "1387440.720368_5861989.908139", "name": "manhole_692_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387440.720367865404114, 5861989.908138634636998 ] } }, -{ "type": "Feature", "properties": { "_index": 691, "bedlevel": 767.60003662109375, "branchid": "pipe_34_E66;pipe_34_E67", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_693_generated", "shape": null, "area": 0.64, "streetlevel": 770.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 770.60003662109375, "distance_right": 3.3575341333343036e-07, "index_right": 700, "nodeid": "1387390.960447_5861990.042768", "id": "1387390.960447_5861990.042768", "name": "manhole_693_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387390.960446665296331, 5861990.042768024839461 ] } }, -{ "type": "Feature", "properties": { "_index": 692, "bedlevel": 767.60003662109375, "branchid": "pipe_34_E67;pipe_34_E68", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_694_generated", "shape": null, "area": 0.64, "streetlevel": 770.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 770.60003662109375, "distance_right": 6.2320378403686381e-07, "index_right": 701, "nodeid": "1387341.200525_5861990.177397", "id": "1387341.200525_5861990.177397", "name": "manhole_694_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387341.200525465421379, 5861990.177397414110601 ] } }, -{ "type": "Feature", "properties": { "_index": 693, "bedlevel": 746.60003662109375, "branchid": "pipe_34_E68;pipe_34_E69", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_695_generated", "shape": null, "area": 0.64, "streetlevel": 749.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 749.60003662109375, "distance_right": 3.2988750062887901e-07, "index_right": 702, "nodeid": "1387291.440604_5861990.312027", "id": "1387291.440604_5861990.312027", "name": "manhole_695_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387291.440604265546426, 5861990.312026804313064 ] } }, -{ "type": "Feature", "properties": { "_index": 694, "bedlevel": 746.60003662109375, "branchid": "pipe_34_E69;pipe_34_E70", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_696_generated", "shape": null, "area": 0.64, "streetlevel": 749.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 749.60003662109375, "distance_right": 5.3662372160015116e-07, "index_right": 703, "nodeid": "1387246.706285_5861974.212806", "id": "1387246.706285_5861974.212806", "name": "manhole_696_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387246.706285298336297, 5861974.212805554270744 ] } }, -{ "type": "Feature", "properties": { "_index": 695, "bedlevel": 744.0, "branchid": "pipe_34_E70;pipe_34_E71", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_697_generated", "shape": null, "area": 0.64, "streetlevel": 747.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 747.0, "distance_right": 2.9919235981069635e-07, "index_right": 704, "nodeid": "1387205.725989_5861945.987229", "id": "1387205.725989_5861945.987229", "name": "manhole_697_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387205.725988702848554, 5861945.987228964455426 ] } }, -{ "type": "Feature", "properties": { "_index": 696, "bedlevel": 768.79998779296875, "branchid": "pipe_34_E71;pipe_34_E72", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_698_generated", "shape": null, "area": 0.64, "streetlevel": 771.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 771.79998779296875, "distance_right": 3.8940979095391863e-07, "index_right": 705, "nodeid": "1387164.745692_5861917.761652", "id": "1387164.745692_5861917.761652", "name": "manhole_698_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387164.745692107127979, 5861917.761652374640107 ] } }, -{ "type": "Feature", "properties": { "_index": 697, "bedlevel": 761.10003662109375, "branchid": "pipe_34_E72;pipe_34_E73", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_699_generated", "shape": null, "area": 0.64, "streetlevel": 764.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 764.10003662109375, "distance_right": 4.3735146338226453e-07, "index_right": 706, "nodeid": "1387115.569934_5861911.215812", "id": "1387115.569934_5861911.215812", "name": "manhole_699_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387115.569933785125613, 5861911.215812381356955 ] } }, -{ "type": "Feature", "properties": { "_index": 698, "bedlevel": 761.10003662109375, "branchid": "pipe_34_E73;pipe_34_E74", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_700_generated", "shape": null, "area": 0.64, "streetlevel": 764.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 764.10003662109375, "distance_right": 4.4995899873023288e-07, "index_right": 707, "nodeid": "1387066.165866_5861905.273926", "id": "1387066.165866_5861905.273926", "name": "manhole_700_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387066.165866439929232, 5861905.273926095105708 ] } }, -{ "type": "Feature", "properties": { "_index": 699, "bedlevel": 744.70001220703125, "branchid": "pipe_34_E74;pipe_34_E75", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_701_generated", "shape": null, "area": 0.64, "streetlevel": 747.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 747.70001220703125, "distance_right": 4.8367488329805678e-07, "index_right": 708, "nodeid": "1387016.666836_5861900.238133", "id": "1387016.666836_5861900.238133", "name": "manhole_701_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387016.666836149292067, 5861900.238133460283279 ] } }, -{ "type": "Feature", "properties": { "_index": 700, "bedlevel": 744.70001220703125, "branchid": "pipe_34_E75;pipe_34_E76", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_702_generated", "shape": null, "area": 0.64, "streetlevel": 747.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 747.70001220703125, "distance_right": 4.5868611841636618e-07, "index_right": 709, "nodeid": "1386975.698310_5861874.842493", "id": "1386975.698310_5861874.842493", "name": "manhole_702_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386975.698310127714649, 5861874.842493440955877 ] } }, -{ "type": "Feature", "properties": { "_index": 701, "bedlevel": 736.60003662109375, "branchid": "pipe_34_E76;pipe_34_E77", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_703_generated", "shape": null, "area": 0.64, "streetlevel": 739.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 739.60003662109375, "distance_right": 2.4490286576639853e-07, "index_right": 710, "nodeid": "1386937.286020_5861843.210803", "id": "1386937.286020_5861843.210803", "name": "manhole_703_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386937.286019780673087, 5861843.21080310922116 ] } }, -{ "type": "Feature", "properties": { "_index": 702, "bedlevel": 736.60003662109375, "branchid": "pipe_34_E77;pipe_34_E78", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_704_generated", "shape": null, "area": 0.64, "streetlevel": 739.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 739.60003662109375, "distance_right": 4.8711559489137913e-07, "index_right": 711, "nodeid": "1386898.873729_5861811.579113", "id": "1386898.873729_5861811.579113", "name": "manhole_704_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386898.873729433864355, 5861811.579112778417766 ] } }, -{ "type": "Feature", "properties": { "_index": 703, "bedlevel": 752.20001220703125, "branchid": "pipe_34_E78;pipe_34_E79", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_705_generated", "shape": null, "area": 0.64, "streetlevel": 755.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 755.20001220703125, "distance_right": 4.5635115012089555e-07, "index_right": 712, "nodeid": "1386860.461439_5861779.947422", "id": "1386860.461439_5861779.947422", "name": "manhole_705_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386860.461439087055624, 5861779.947422447614372 ] } }, -{ "type": "Feature", "properties": { "_index": 704, "bedlevel": 742.29998779296875, "branchid": "pipe_34_E79;pipe_34_E80", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_706_generated", "shape": null, "area": 0.64, "streetlevel": 745.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 745.29998779296875, "distance_right": 2.8455915079755038e-07, "index_right": 713, "nodeid": "1386822.049149_5861748.315732", "id": "1386822.049149_5861748.315732", "name": "manhole_706_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386822.049148740014061, 5861748.315732115879655 ] } }, -{ "type": "Feature", "properties": { "_index": 705, "bedlevel": 742.29998779296875, "branchid": "pipe_34_E80;pipe_34_E81", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_707_generated", "shape": null, "area": 0.64, "streetlevel": 745.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 745.29998779296875, "distance_right": 3.5457500391329842e-07, "index_right": 714, "nodeid": "1386774.418702_5861733.958942", "id": "1386774.418702_5861733.958942", "name": "manhole_707_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386774.418702265014872, 5861733.958941764198244 ] } }, -{ "type": "Feature", "properties": { "_index": 706, "bedlevel": 721.29998779296875, "branchid": "pipe_34_E81;pipe_34_E82", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_708_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 3.9676643957092681e-07, "index_right": 715, "nodeid": "1386726.757215_5861719.660322", "id": "1386726.757215_5861719.660322", "name": "manhole_708_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386726.75721522886306, 5861719.660321676172316 ] } }, -{ "type": "Feature", "properties": { "_index": 707, "bedlevel": 721.29998779296875, "branchid": "pipe_34_E82;pipe_34_E83", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_709_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 6.4005122766323423e-07, "index_right": 716, "nodeid": "1386681.211288_5861700.510516", "id": "1386681.211288_5861700.510516", "name": "manhole_709_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386681.211287560872734, 5861700.510515534318984 ] } }, -{ "type": "Feature", "properties": { "_index": 708, "bedlevel": 774.9000244140625, "branchid": "pipe_34_E83;pipe_34_E84", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_710_generated", "shape": null, "area": 0.64, "streetlevel": 777.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 777.9000244140625, "distance_right": 1.6268731961636028e-07, "index_right": 717, "nodeid": "1386655.081909_5861659.807658", "id": "1386655.081909_5861659.807658", "name": "manhole_710_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386655.081909105414525, 5861659.807657876051962 ] } }, -{ "type": "Feature", "properties": { "_index": 709, "bedlevel": 755.79998779296875, "branchid": "pipe_34_E84;pipe_34_E85", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_711_generated", "shape": null, "area": 0.64, "streetlevel": 758.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 758.79998779296875, "distance_right": 4.863711772445947e-07, "index_right": 718, "nodeid": "1386647.411753_5861610.757949", "id": "1386647.411753_5861610.757949", "name": "manhole_711_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386647.41175345890224, 5861610.757949161343277 ] } }, -{ "type": "Feature", "properties": { "_index": 710, "bedlevel": 755.79998779296875, "branchid": "pipe_34_E85;pipe_34_E86", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_712_generated", "shape": null, "area": 0.64, "streetlevel": 758.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 758.79998779296875, "distance_right": 4.9930356460427038e-07, "index_right": 719, "nodeid": "1386641.745189_5861561.363540", "id": "1386641.745189_5861561.363540", "name": "manhole_712_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386641.745189253240824, 5861561.363539570011199 ] } }, -{ "type": "Feature", "properties": { "_index": 711, "bedlevel": 729.4000244140625, "branchid": "pipe_34_E86;pipe_34_E87", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_713_generated", "shape": null, "area": 0.64, "streetlevel": 732.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 732.4000244140625, "distance_right": 2.7534652721036083e-07, "index_right": 720, "nodeid": "1386642.371349_5861511.607376", "id": "1386642.371349_5861511.607376", "name": "manhole_713_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386642.37134926696308, 5861511.607376066967845 ] } }, -{ "type": "Feature", "properties": { "_index": 712, "bedlevel": 729.4000244140625, "branchid": "pipe_34_E87;pipe_34_E88", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_714_generated", "shape": null, "area": 0.64, "streetlevel": 732.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 732.4000244140625, "distance_right": 5.1860291152319888e-07, "index_right": 721, "nodeid": "1386642.997509_5861461.851213", "id": "1386642.997509_5861461.851213", "name": "manhole_714_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386642.997509280918166, 5861461.851212563924491 ] } }, -{ "type": "Feature", "properties": { "_index": 713, "bedlevel": 729.4000244140625, "branchid": "pipe_34_E88;pipe_34_E89", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_715_generated", "shape": null, "area": 0.64, "streetlevel": 732.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 732.4000244140625, "distance_right": 3.008763845900145e-07, "index_right": 722, "nodeid": "1386643.623669_5861412.095049", "id": "1386643.623669_5861412.095049", "name": "manhole_715_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386643.623669294640422, 5861412.09504906181246 ] } }, -{ "type": "Feature", "properties": { "_index": 715, "bedlevel": 777.79998779296875, "branchid": "pipe_35_E0;pipe_36_E0;pipe_37_E0", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_716_generated", "shape": null, "area": 0.64, "streetlevel": 780.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 780.79998779296875, "distance_right": 2.3980109538029568e-07, "index_right": 723, "nodeid": "1386060.978602_5859873.390329", "id": "1386060.978602_5859873.390329", "name": "manhole_716_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386060.978602184914052, 5859873.390328846871853 ] } }, -{ "type": "Feature", "properties": { "_index": 715, "bedlevel": 777.79998779296875, "branchid": "pipe_35_E0;pipe_35_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_717_generated", "shape": null, "area": 0.64, "streetlevel": 780.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 780.79998779296875, "distance_right": 5.4068790112897243e-07, "index_right": 724, "nodeid": "1386078.544554_5859857.065600", "id": "1386078.544554_5859857.065600", "name": "manhole_717_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386078.54455375042744, 5859857.065600479952991 ] } }, -{ "type": "Feature", "properties": { "_index": 716, "bedlevel": 777.79998779296875, "branchid": "pipe_35_E1;pipe_38_E0;pipe_39_E0", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_718_generated", "shape": null, "area": 0.64, "streetlevel": 780.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 780.79998779296875, "distance_right": 5.758455387466089e-07, "index_right": 725, "nodeid": "1386079.866959_5859885.500409", "id": "1386079.866959_5859885.500409", "name": "manhole_718_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386079.86695942771621, 5859885.500408614054322 ] } }, -{ "type": "Feature", "properties": { "_index": 717, "bedlevel": 777.79998779296875, "branchid": "pipe_36_E0", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_719_generated", "shape": null, "area": 0.64, "streetlevel": 780.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 780.79998779296875, "distance_right": 5.0283226172582603e-07, "index_right": 726, "nodeid": "1386030.926458_5859869.881591", "id": "1386030.926458_5859869.881591", "name": "manhole_719_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386030.926458492642269, 5859869.881591100245714 ] } }, -{ "type": "Feature", "properties": { "_index": 718, "bedlevel": 763.29998779296875, "branchid": "pipe_37_E0", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_720_generated", "shape": null, "area": 0.64, "streetlevel": 766.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 766.29998779296875, "distance_right": 2.4131141216608354e-07, "index_right": 727, "nodeid": "1386043.381106_5859908.119292", "id": "1386043.381106_5859908.119292", "name": "manhole_720_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386043.381105761509389, 5859908.11929196305573 ] } }, -{ "type": "Feature", "properties": { "_index": 719, "bedlevel": 763.29998779296875, "branchid": "pipe_38_E0;pipe_38_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_721_generated", "shape": null, "area": 0.64, "streetlevel": 766.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 766.29998779296875, "distance_right": 4.3100518037512075e-07, "index_right": 728, "nodeid": "1386081.403634_5859934.756706", "id": "1386081.403634_5859934.756706", "name": "manhole_721_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386081.40363402524963, 5859934.756705570034683 ] } }, -{ "type": "Feature", "properties": { "_index": 720, "bedlevel": 763.29998779296875, "branchid": "pipe_38_E1;pipe_38_E2", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_722_generated", "shape": null, "area": 0.64, "streetlevel": 766.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 766.29998779296875, "distance_right": 2.071517671303778e-07, "index_right": 729, "nodeid": "1386080.471782_5859983.948014", "id": "1386080.471782_5859983.948014", "name": "manhole_722_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386080.471781946951523, 5859983.948014200665057 ] } }, -{ "type": "Feature", "properties": { "_index": 721, "bedlevel": 753.5, "branchid": "pipe_38_E2;pipe_39_E3;pipe_40_E0", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_723_generated", "shape": null, "area": 0.64, "streetlevel": 756.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 756.5, "distance_right": 1.3487809052132004e-07, "index_right": 730, "nodeid": "1386081.101270_5860033.019892", "id": "1386081.101270_5860033.019892", "name": "manhole_723_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386081.101269942475483, 5860033.01989212166518 ] } }, -{ "type": "Feature", "properties": { "_index": 722, "bedlevel": 763.29998779296875, "branchid": "pipe_39_E0;pipe_39_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_724_generated", "shape": null, "area": 0.64, "streetlevel": 766.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 766.29998779296875, "distance_right": 4.0608894916904316e-07, "index_right": 731, "nodeid": "1386051.415039_5859913.714704", "id": "1386051.415039_5859913.714704", "name": "manhole_724_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386051.415038994979113, 5859913.714703594334424 ] } }, -{ "type": "Feature", "properties": { "_index": 723, "bedlevel": 763.29998779296875, "branchid": "pipe_39_E1;pipe_39_E2", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_725_generated", "shape": null, "area": 0.64, "streetlevel": 766.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 766.29998779296875, "distance_right": 3.9667516038273416e-07, "index_right": 732, "nodeid": "1386056.753748_5859949.432773", "id": "1386056.753748_5859949.432773", "name": "manhole_725_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386056.753747603856027, 5859949.43277302198112 ] } }, -{ "type": "Feature", "properties": { "_index": 724, "bedlevel": 763.29998779296875, "branchid": "pipe_39_E2;pipe_39_E3", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_726_generated", "shape": null, "area": 0.64, "streetlevel": 766.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 766.29998779296875, "distance_right": 4.4652043281523293e-07, "index_right": 733, "nodeid": "1386070.153564_5859990.873222", "id": "1386070.153564_5859990.873222", "name": "manhole_726_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386070.153564189793542, 5859990.873222404159606 ] } }, -{ "type": "Feature", "properties": { "_index": 726, "bedlevel": 753.5, "branchid": "pipe_40_E0;pipe_40_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_727_generated", "shape": null, "area": 0.64, "streetlevel": 756.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 756.5, "distance_right": 6.8990088841665868e-07, "index_right": 734, "nodeid": "1386095.159511_5860079.476792", "id": "1386095.159511_5860079.476792", "name": "manhole_727_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386095.159510504920036, 5860079.476792480796576 ] } }, -{ "type": "Feature", "properties": { "_index": 727, "bedlevel": 717.29998779296875, "branchid": "pipe_40_E1;pipe_40_E2", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_728_generated", "shape": null, "area": 0.64, "streetlevel": 720.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 720.29998779296875, "distance_right": 5.9386567370106793e-07, "index_right": 735, "nodeid": "1386119.249575_5860122.285581", "id": "1386119.249575_5860122.285581", "name": "manhole_728_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386119.249574675457552, 5860122.285581497475505 ] } }, -{ "type": "Feature", "properties": { "_index": 728, "bedlevel": 717.29998779296875, "branchid": "pipe_40_E2;pipe_40_E3", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_729_generated", "shape": null, "area": 0.64, "streetlevel": 720.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 720.29998779296875, "distance_right": 4.1965829506765982e-07, "index_right": 736, "nodeid": "1386143.813146_5860164.822059", "id": "1386143.813146_5860164.822059", "name": "manhole_729_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386143.813145637512207, 5860164.822058788500726 ] } }, -{ "type": "Feature", "properties": { "_index": 729, "bedlevel": 729.5, "branchid": "pipe_40_E3;pipe_40_E4", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_730_generated", "shape": null, "area": 0.64, "streetlevel": 732.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 732.5, "distance_right": 2.4941759242771704e-07, "index_right": 737, "nodeid": "1386168.698390_5860207.173543", "id": "1386168.698390_5860207.173543", "name": "manhole_730_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386168.698389830067754, 5860207.173543182201684 ] } }, -{ "type": "Feature", "properties": { "_index": 730, "bedlevel": 729.5, "branchid": "pipe_40_E4;pipe_40_E5", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_731_generated", "shape": null, "area": 0.64, "streetlevel": 732.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 732.5, "distance_right": 4.7271295433509584e-07, "index_right": 738, "nodeid": "1386190.960879_5860250.914159", "id": "1386190.960879_5860250.914159", "name": "manhole_731_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386190.960878706537187, 5860250.914158629253507 ] } }, -{ "type": "Feature", "properties": { "_index": 731, "bedlevel": 717.29998779296875, "branchid": "pipe_40_E5;pipe_40_E6", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_732_generated", "shape": null, "area": 0.64, "streetlevel": 720.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 720.29998779296875, "distance_right": 5.9534977694369198e-07, "index_right": 739, "nodeid": "1386212.013376_5860295.295641", "id": "1386212.013376_5860295.295641", "name": "manhole_732_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386212.013376480899751, 5860295.295640649273992 ] } }, -{ "type": "Feature", "properties": { "_index": 732, "bedlevel": 726.10003662109375, "branchid": "pipe_40_E6;pipe_40_E7", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_733_generated", "shape": null, "area": 0.64, "streetlevel": 729.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 729.10003662109375, "distance_right": 4.1705063981150445e-07, "index_right": 740, "nodeid": "1386233.065874_5860339.677123", "id": "1386233.065874_5860339.677123", "name": "manhole_733_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386233.065874255495146, 5860339.677122670225799 ] } }, -{ "type": "Feature", "properties": { "_index": 733, "bedlevel": 726.10003662109375, "branchid": "pipe_40_E7;pipe_40_E8", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_734_generated", "shape": null, "area": 0.64, "streetlevel": 729.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 729.10003662109375, "distance_right": 3.1158142785059036e-07, "index_right": 741, "nodeid": "1386254.118372_5860384.058605", "id": "1386254.118372_5860384.058605", "name": "manhole_734_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386254.118372030090541, 5860384.058604690246284 ] } }, -{ "type": "Feature", "properties": { "_index": 734, "bedlevel": 726.10003662109375, "branchid": "pipe_40_E8;pipe_40_E9", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_735_generated", "shape": null, "area": 0.64, "streetlevel": 729.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 729.10003662109375, "distance_right": 1.7018263719686392e-07, "index_right": 742, "nodeid": "1386270.265550_5860430.368607", "id": "1386270.265550_5860430.368607", "name": "manhole_735_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386270.265550139825791, 5860430.368606903590262 ] } }, -{ "type": "Feature", "properties": { "_index": 735, "bedlevel": 743.10003662109375, "branchid": "pipe_40_E9;pipe_40_E10", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_736_generated", "shape": null, "area": 0.64, "streetlevel": 746.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 746.10003662109375, "distance_right": 4.8813570520896638e-07, "index_right": 743, "nodeid": "1386284.690117_5860477.310511", "id": "1386284.690117_5860477.310511", "name": "manhole_736_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386284.690116602927446, 5860477.310510716401041 ] } }, -{ "type": "Feature", "properties": { "_index": 736, "bedlevel": 743.10003662109375, "branchid": "pipe_40_E10;pipe_40_E11", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_737_generated", "shape": null, "area": 0.64, "streetlevel": 746.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 746.10003662109375, "distance_right": 4.7960060831833522e-07, "index_right": 744, "nodeid": "1386295.943752_5860525.125564", "id": "1386295.943752_5860525.125564", "name": "manhole_737_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386295.943752367515117, 5860525.125563691370189 ] } }, -{ "type": "Feature", "properties": { "_index": 737, "bedlevel": 717.29998779296875, "branchid": "pipe_40_E11;pipe_40_E12", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_738_generated", "shape": null, "area": 0.64, "streetlevel": 720.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 720.29998779296875, "distance_right": 3.5954962138553505e-07, "index_right": 745, "nodeid": "1386307.197388_5860572.940617", "id": "1386307.197388_5860572.940617", "name": "manhole_738_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386307.197388132335618, 5860572.940616665408015 ] } }, -{ "type": "Feature", "properties": { "_index": 738, "bedlevel": 717.29998779296875, "branchid": "pipe_40_E12;pipe_40_E13", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_739_generated", "shape": null, "area": 0.64, "streetlevel": 720.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 720.29998779296875, "distance_right": 3.7399479825356605e-07, "index_right": 746, "nodeid": "1386318.451024_5860620.755670", "id": "1386318.451024_5860620.755670", "name": "manhole_739_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386318.451023896923289, 5860620.755669640377164 ] } }, -{ "type": "Feature", "properties": { "_index": 739, "bedlevel": 717.29998779296875, "branchid": "pipe_40_E13;pipe_40_E14", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_740_generated", "shape": null, "area": 0.64, "streetlevel": 720.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 720.29998779296875, "distance_right": 5.1309725242743082e-07, "index_right": 747, "nodeid": "1386329.704660_5860668.570723", "id": "1386329.704660_5860668.570723", "name": "manhole_740_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386329.704659661510959, 5860668.57072261441499 ] } }, -{ "type": "Feature", "properties": { "_index": 740, "bedlevel": 734.60003662109375, "branchid": "pipe_40_E14;pipe_40_E15", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_741_generated", "shape": null, "area": 0.64, "streetlevel": 737.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 737.60003662109375, "distance_right": 5.9196965643961131e-07, "index_right": 748, "nodeid": "1386340.958295_5860716.385776", "id": "1386340.958295_5860716.385776", "name": "manhole_741_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386340.95829542633146, 5860716.385775589384139 ] } }, -{ "type": "Feature", "properties": { "_index": 741, "bedlevel": 734.60003662109375, "branchid": "pipe_40_E15;pipe_40_E16", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_742_generated", "shape": null, "area": 0.64, "streetlevel": 737.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 737.60003662109375, "distance_right": 4.7669343638089868e-07, "index_right": 749, "nodeid": "1386352.211931_5860764.200829", "id": "1386352.211931_5860764.200829", "name": "manhole_742_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386352.211931190919131, 5860764.200828563421965 ] } }, -{ "type": "Feature", "properties": { "_index": 742, "bedlevel": 734.60003662109375, "branchid": "pipe_40_E16;pipe_40_E17", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_743_generated", "shape": null, "area": 0.64, "streetlevel": 737.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 737.60003662109375, "distance_right": 3.76122032946863e-07, "index_right": 750, "nodeid": "1386365.771370_5860811.365820", "id": "1386365.771370_5860811.365820", "name": "manhole_743_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386365.771370212780312, 5860811.365820310078561 ] } }, -{ "type": "Feature", "properties": { "_index": 743, "bedlevel": 741.5, "branchid": "pipe_40_E17;pipe_40_E18", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_744_generated", "shape": null, "area": 0.64, "streetlevel": 744.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 744.5, "distance_right": 6.6936522197239387e-07, "index_right": 751, "nodeid": "1386381.150273_5860858.017861", "id": "1386381.150273_5860858.017861", "name": "manhole_744_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386381.150273493025452, 5860858.017861452884972 ] } }, -{ "type": "Feature", "properties": { "_index": 744, "bedlevel": 721.29998779296875, "branchid": "pipe_40_E18;pipe_40_E19", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_745_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 3.9416955839349739e-07, "index_right": 752, "nodeid": "1386398.399082_5860903.951519", "id": "1386398.399082_5860903.951519", "name": "manhole_745_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386398.399082327727228, 5860903.951519219204783 ] } }, -{ "type": "Feature", "properties": { "_index": 745, "bedlevel": 721.29998779296875, "branchid": "pipe_40_E19;pipe_40_E20", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_746_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 5.567527440022547e-07, "index_right": 753, "nodeid": "1386418.211524_5860948.900276", "id": "1386418.211524_5860948.900276", "name": "manhole_746_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386418.211523674428463, 5860948.90027645137161 ] } }, -{ "type": "Feature", "properties": { "_index": 746, "bedlevel": 721.29998779296875, "branchid": "pipe_40_E20;pipe_40_E21", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_747_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 4.8463423027554962e-07, "index_right": 754, "nodeid": "1386441.678376_5860992.033180", "id": "1386441.678376_5860992.033180", "name": "manhole_747_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386441.67837643600069, 5860992.033180211670697 ] } }, -{ "type": "Feature", "properties": { "_index": 747, "bedlevel": 721.29998779296875, "branchid": "pipe_40_E21;pipe_40_E22", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_748_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 3.4573908100037007e-07, "index_right": 755, "nodeid": "1386465.536531_5861034.971649", "id": "1386465.536531_5861034.971649", "name": "manhole_748_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386465.536530936835334, 5861034.971648660488427 ] } }, -{ "type": "Feature", "properties": { "_index": 748, "bedlevel": 721.9000244140625, "branchid": "pipe_40_E22;pipe_40_E23", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_749_generated", "shape": null, "area": 0.64, "streetlevel": 724.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.9000244140625, "distance_right": 4.5085446316371647e-07, "index_right": 756, "nodeid": "1386489.394685_5861077.910117", "id": "1386489.394685_5861077.910117", "name": "manhole_749_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386489.394685437437147, 5861077.910117109306157 ] } }, -{ "type": "Feature", "properties": { "_index": 749, "bedlevel": 721.29998779296875, "branchid": "pipe_40_E23;pipe_40_E24", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_750_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 4.4666027024101134e-07, "index_right": 757, "nodeid": "1386513.252840_5861120.848586", "id": "1386513.252840_5861120.848586", "name": "manhole_750_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386513.252839938271791, 5861120.848585557192564 ] } }, -{ "type": "Feature", "properties": { "_index": 750, "bedlevel": 721.29998779296875, "branchid": "pipe_40_E24;pipe_40_E25", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_751_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 4.3892133490986504e-07, "index_right": 758, "nodeid": "1386537.110994_5861163.787054", "id": "1386537.110994_5861163.787054", "name": "manhole_751_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386537.110994438873604, 5861163.787054006010294 ] } }, -{ "type": "Feature", "properties": { "_index": 751, "bedlevel": 721.29998779296875, "branchid": "pipe_40_E25;pipe_40_E26", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_752_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 4.5846860528081458e-07, "index_right": 759, "nodeid": "1386560.969149_5861206.725522", "id": "1386560.969149_5861206.725522", "name": "manhole_752_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386560.969148939708248, 5861206.725522454828024 ] } }, -{ "type": "Feature", "properties": { "_index": 752, "bedlevel": 721.29998779296875, "branchid": "pipe_40_E26;pipe_40_E27", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_753_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 4.5081069418943963e-07, "index_right": 760, "nodeid": "1386584.827303_5861249.663991", "id": "1386584.827303_5861249.663991", "name": "manhole_753_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386584.827303440310061, 5861249.663990902714431 ] } }, -{ "type": "Feature", "properties": { "_index": 753, "bedlevel": 721.29998779296875, "branchid": "pipe_40_E27;pipe_40_E28", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_754_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 4.9127734780403708e-07, "index_right": 761, "nodeid": "1386607.696082_5861293.105181", "id": "1386607.696082_5861293.105181", "name": "manhole_754_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386607.696082097478211, 5861293.105181481689215 ] } }, -{ "type": "Feature", "properties": { "_index": 754, "bedlevel": 721.29998779296875, "branchid": "pipe_40_E28;pipe_40_E29", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_755_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 3.8526999555463843e-07, "index_right": 762, "nodeid": "1386626.999141_5861338.164891", "id": "1386626.999141_5861338.164891", "name": "manhole_755_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386626.999141034670174, 5861338.164890616200864 ] } }, -{ "type": "Feature", "properties": { "_index": 755, "bedlevel": 729.4000244140625, "branchid": "pipe_40_E29;pipe_40_E30", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_756_generated", "shape": null, "area": 0.64, "streetlevel": 732.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 732.4000244140625, "distance_right": 4.840163814950507e-07, "index_right": 763, "nodeid": "1386632.635545_5861386.242181", "id": "1386632.635545_5861386.242181", "name": "manhole_756_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386632.635544582502916, 5861386.242180755361915 ] } }, -{ "type": "Feature", "properties": { "_index": 756, "bedlevel": 729.4000244140625, "branchid": "pipe_40_E30;pipe_40_E31", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_757_generated", "shape": null, "area": 0.64, "streetlevel": 732.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 732.4000244140625, "distance_right": 2.6142848419208022e-07, "index_right": 764, "nodeid": "1386628.332881_5861435.174897", "id": "1386628.332881_5861435.174897", "name": "manhole_757_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386628.332881111185998, 5861435.174896763637662 ] } }, -{ "type": "Feature", "properties": { "_index": 757, "bedlevel": 729.4000244140625, "branchid": "pipe_40_E31;pipe_40_E32", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_758_generated", "shape": null, "area": 0.64, "streetlevel": 732.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 732.4000244140625, "distance_right": 4.2637953535945764e-07, "index_right": 765, "nodeid": "1386624.030218_5861484.107613", "id": "1386624.030218_5861484.107613", "name": "manhole_758_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386624.030217639869079, 5861484.107612771913409 ] } }, -{ "type": "Feature", "properties": { "_index": 758, "bedlevel": 755.79998779296875, "branchid": "pipe_40_E32;pipe_40_E33", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_759_generated", "shape": null, "area": 0.64, "streetlevel": 758.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 758.79998779296875, "distance_right": 2.7773094778815831e-07, "index_right": 766, "nodeid": "1386619.727554_5861533.040329", "id": "1386619.727554_5861533.040329", "name": "manhole_759_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386619.72755416855216, 5861533.040328779257834 ] } }, -{ "type": "Feature", "properties": { "_index": 759, "bedlevel": 755.79998779296875, "branchid": "pipe_40_E33;pipe_40_E34", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_760_generated", "shape": null, "area": 0.64, "streetlevel": 758.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 758.79998779296875, "distance_right": 1.3255917795466179e-07, "index_right": 767, "nodeid": "1386620.396810_5861581.843450", "id": "1386620.396810_5861581.843450", "name": "manhole_760_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386620.396809899713844, 5861581.843449912965298 ] } }, -{ "type": "Feature", "properties": { "_index": 760, "bedlevel": 755.79998779296875, "branchid": "pipe_40_E34;pipe_40_E35", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_761_generated", "shape": null, "area": 0.64, "streetlevel": 758.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 758.79998779296875, "distance_right": 3.3282772002277633e-07, "index_right": 768, "nodeid": "1386627.242797_5861630.485572", "id": "1386627.242797_5861630.485572", "name": "manhole_761_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386627.242796876933426, 5861630.485572309233248 ] } }, -{ "type": "Feature", "properties": { "_index": 761, "bedlevel": 774.9000244140625, "branchid": "pipe_40_E35;pipe_40_E36", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_762_generated", "shape": null, "area": 0.64, "streetlevel": 777.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 777.9000244140625, "distance_right": 5.4635113303875806e-07, "index_right": 769, "nodeid": "1386633.497010_5861679.177459", "id": "1386633.497010_5861679.177459", "name": "manhole_762_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386633.497009602142498, 5861679.177458625286818 ] } }, -{ "type": "Feature", "properties": { "_index": 762, "bedlevel": 774.9000244140625, "branchid": "pipe_40_E36;pipe_40_E37", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_763_generated", "shape": null, "area": 0.64, "streetlevel": 777.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 777.9000244140625, "distance_right": 5.846229101433154e-07, "index_right": 770, "nodeid": "1386633.587327_5861728.232038", "id": "1386633.587327_5861728.232038", "name": "manhole_763_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386633.587326586712152, 5861728.232037586160004 ] } }, -{ "type": "Feature", "properties": { "_index": 763, "bedlevel": 774.9000244140625, "branchid": "pipe_40_E37;pipe_40_E38", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_764_generated", "shape": null, "area": 0.64, "streetlevel": 777.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 777.9000244140625, "distance_right": 2.2543790250488301e-07, "index_right": 771, "nodeid": "1386628.569952_5861777.096642", "id": "1386628.569952_5861777.096642", "name": "manhole_764_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386628.569951781770214, 5861777.096641942858696 ] } }, -{ "type": "Feature", "properties": { "_index": 764, "bedlevel": 784.0, "branchid": "pipe_40_E38;pipe_41_E0", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_765_generated", "shape": null, "area": 0.64, "streetlevel": 787.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 787.0, "distance_right": 3.0078835670256984e-07, "index_right": 772, "nodeid": "1386623.552577_5861825.961246", "id": "1386623.552577_5861825.961246", "name": "manhole_765_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386623.552576976828277, 5861825.961246299557388 ] } }, -{ "type": "Feature", "properties": { "_index": 765, "bedlevel": 784.0, "branchid": "pipe_41_E0;pipe_41_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_766_generated", "shape": null, "area": 0.64, "streetlevel": 787.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 787.0, "distance_right": 3.86942464847858e-07, "index_right": 773, "nodeid": "1386622.452885_5861875.377416", "id": "1386622.452885_5861875.377416", "name": "manhole_766_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386622.452884682221338, 5861875.377415779046714 ] } }, -{ "type": "Feature", "properties": { "_index": 766, "bedlevel": 765.0, "branchid": "pipe_41_E1;pipe_41_E2", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_767_generated", "shape": null, "area": 0.64, "streetlevel": 768.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 768.0, "distance_right": 1.5812903614993457e-07, "index_right": 774, "nodeid": "1386630.050832_5861924.208797", "id": "1386630.050832_5861924.208797", "name": "manhole_767_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386630.050831846194342, 5861924.208797036670148 ] } }, -{ "type": "Feature", "properties": { "_index": 767, "bedlevel": 765.0, "branchid": "pipe_41_E2;pipe_41_E3", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_768_generated", "shape": null, "area": 0.64, "streetlevel": 768.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 768.0, "distance_right": 2.0956943835879417e-07, "index_right": 775, "nodeid": "1386645.112437_5861971.295392", "id": "1386645.112437_5861971.295392", "name": "manhole_768_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386645.112437101313844, 5861971.295391816645861 ] } }, -{ "type": "Feature", "properties": { "_index": 768, "bedlevel": 765.0, "branchid": "pipe_41_E3;pipe_41_E4", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_769_generated", "shape": null, "area": 0.64, "streetlevel": 768.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 768.0, "distance_right": 5.8255627545422018e-07, "index_right": 776, "nodeid": "1386663.826806_5862017.116110", "id": "1386663.826806_5862017.116110", "name": "manhole_769_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386663.826805545249954, 5862017.116109635680914 ] } }, -{ "type": "Feature", "properties": { "_index": 769, "bedlevel": 726.0, "branchid": "pipe_41_E4;pipe_41_E5", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_770_generated", "shape": null, "area": 0.64, "streetlevel": 729.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 729.0, "distance_right": 4.5554265962626818e-07, "index_right": 777, "nodeid": "1386682.541174_5862062.936827", "id": "1386682.541174_5862062.936827", "name": "manhole_770_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386682.541173989186063, 5862062.93682745564729 ] } }, -{ "type": "Feature", "properties": { "_index": 770, "bedlevel": 726.0, "branchid": "pipe_41_E5;pipe_41_E6", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_771_generated", "shape": null, "area": 0.64, "streetlevel": 729.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 729.0, "distance_right": 4.1193130229873742e-07, "index_right": 778, "nodeid": "1386700.357505_5862109.113540", "id": "1386700.357505_5862109.113540", "name": "manhole_771_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386700.357504795538262, 5862109.113540357910097 ] } }, -{ "type": "Feature", "properties": { "_index": 771, "bedlevel": 726.0, "branchid": "pipe_41_E6;pipe_41_E7", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_772_generated", "shape": null, "area": 0.64, "streetlevel": 729.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 729.0, "distance_right": 3.2735028015839139e-07, "index_right": 779, "nodeid": "1386718.120610_5862155.311353", "id": "1386718.120610_5862155.311353", "name": "manhole_772_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386718.120609947945923, 5862155.311352676711977 ] } }, -{ "type": "Feature", "properties": { "_index": 772, "bedlevel": 721.29998779296875, "branchid": "pipe_41_E7;pipe_41_E8", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_773_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 1.0018646052454545e-07, "index_right": 780, "nodeid": "1386735.883715_5862201.509165", "id": "1386735.883715_5862201.509165", "name": "manhole_773_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386735.883715100120753, 5862201.509164996445179 ] } }, -{ "type": "Feature", "properties": { "_index": 773, "bedlevel": 721.29998779296875, "branchid": "pipe_41_E8;pipe_41_E9", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_774_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 1.2663675617332469e-07, "index_right": 781, "nodeid": "1386757.522535_5862245.993861", "id": "1386757.522535_5862245.993861", "name": "manhole_774_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386757.522535112220794, 5862245.993861058726907 ] } }, -{ "type": "Feature", "properties": { "_index": 774, "bedlevel": 721.29998779296875, "branchid": "pipe_41_E9;pipe_41_E10", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_775_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 2.3017284626667885e-07, "index_right": 782, "nodeid": "1386779.730984_5862290.226774", "id": "1386779.730984_5862290.226774", "name": "manhole_775_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386779.73098383564502, 5862290.226773838512599 ] } }, -{ "type": "Feature", "properties": { "_index": 775, "bedlevel": 721.29998779296875, "branchid": "pipe_41_E10;pipe_41_E11", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_776_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 2.0776009455858673e-07, "index_right": 783, "nodeid": "1386802.545179_5862334.095373", "id": "1386802.545179_5862334.095373", "name": "manhole_776_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386802.545179207576439, 5862334.095372994430363 ] } }, -{ "type": "Feature", "properties": { "_index": 776, "bedlevel": 721.29998779296875, "branchid": "pipe_41_E11;pipe_41_E12", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_777_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 3.5309356282638562e-07, "index_right": 784, "nodeid": "1386831.207994_5862374.446443", "id": "1386831.207994_5862374.446443", "name": "manhole_777_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386831.207993831252679, 5862374.446442689746618 ] } }, -{ "type": "Feature", "properties": { "_index": 777, "bedlevel": 734.70001220703125, "branchid": "pipe_41_E12;pipe_41_E13", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_778_generated", "shape": null, "area": 0.64, "streetlevel": 737.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 737.70001220703125, "distance_right": 2.9095978348194408e-07, "index_right": 785, "nodeid": "1386859.988486_5862414.708454", "id": "1386859.988486_5862414.708454", "name": "manhole_778_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386859.988485741894692, 5862414.708453865721822 ] } }, -{ "type": "Feature", "properties": { "_index": 778, "bedlevel": 734.70001220703125, "branchid": "pipe_41_E13;pipe_41_E14", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_779_generated", "shape": null, "area": 0.64, "streetlevel": 737.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 737.70001220703125, "distance_right": 2.7843430015560495e-07, "index_right": 786, "nodeid": "1386891.035651_5862453.255040", "id": "1386891.035651_5862453.255040", "name": "manhole_779_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386891.035651177866384, 5862453.255039785988629 ] } }, -{ "type": "Feature", "properties": { "_index": 779, "bedlevel": 740.9000244140625, "branchid": "pipe_41_E14;pipe_41_E15", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_780_generated", "shape": null, "area": 0.64, "streetlevel": 743.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 743.9000244140625, "distance_right": 4.842933356581801e-07, "index_right": 787, "nodeid": "1386922.082817_5862491.801626", "id": "1386922.082817_5862491.801626", "name": "manhole_780_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386922.082816614070907, 5862491.801625707186759 ] } }, -{ "type": "Feature", "properties": { "_index": 780, "bedlevel": 753.0, "branchid": "pipe_41_E15;pipe_41_E16", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_781_generated", "shape": null, "area": 0.64, "streetlevel": 756.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 756.0, "distance_right": 3.7590837301943507e-07, "index_right": 788, "nodeid": "1386953.129982_5862530.348212", "id": "1386953.129982_5862530.348212", "name": "manhole_781_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386953.12998205027543, 5862530.348211627453566 ] } }, -{ "type": "Feature", "properties": { "_index": 781, "bedlevel": 753.0, "branchid": "pipe_41_E16;pipe_41_E17", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_782_generated", "shape": null, "area": 0.64, "streetlevel": 756.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 756.0, "distance_right": 6.6440650546458733e-07, "index_right": 789, "nodeid": "1386984.177147_5862568.894798", "id": "1386984.177147_5862568.894798", "name": "manhole_782_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386984.177147486479953, 5862568.894797547720373 ] } }, -{ "type": "Feature", "properties": { "_index": 782, "bedlevel": 758.4000244140625, "branchid": "pipe_41_E17;pipe_41_E18", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_783_generated", "shape": null, "area": 0.64, "streetlevel": 761.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 761.4000244140625, "distance_right": 5.6406653307900537e-07, "index_right": 790, "nodeid": "1387010.831901_5862610.297833", "id": "1387010.831901_5862610.297833", "name": "manhole_783_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387010.83190148579888, 5862610.297833287157118 ] } }, -{ "type": "Feature", "properties": { "_index": 783, "bedlevel": 758.4000244140625, "branchid": "pipe_41_E18;pipe_41_E19", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_784_generated", "shape": null, "area": 0.64, "streetlevel": 761.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 761.4000244140625, "distance_right": 5.0755547669671581e-07, "index_right": 791, "nodeid": "1387033.474099_5862654.310294", "id": "1387033.474099_5862654.310294", "name": "manhole_784_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387033.474099110113457, 5862654.310293504968286 ] } }, -{ "type": "Feature", "properties": { "_index": 784, "bedlevel": 767.5, "branchid": "pipe_41_E19;pipe_41_E20", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_785_generated", "shape": null, "area": 0.64, "streetlevel": 770.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 770.5, "distance_right": 3.8351560851169947e-07, "index_right": 792, "nodeid": "1387056.116297_5862698.322754", "id": "1387056.116297_5862698.322754", "name": "manhole_785_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387056.116296734428033, 5862698.322753723710775 ] } }, -{ "type": "Feature", "properties": { "_index": 785, "bedlevel": 762.29998779296875, "branchid": "pipe_41_E20;pipe_41_E21", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_786_generated", "shape": null, "area": 0.64, "streetlevel": 765.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 765.29998779296875, "distance_right": 3.6340865905868276e-07, "index_right": 793, "nodeid": "1387078.758494_5862742.335214", "id": "1387078.758494_5862742.335214", "name": "manhole_786_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387078.75849435874261, 5862742.335213942453265 ] } }, -{ "type": "Feature", "properties": { "_index": 786, "bedlevel": 762.29998779296875, "branchid": "pipe_41_E21;pipe_41_E22", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_787_generated", "shape": null, "area": 0.64, "streetlevel": 765.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 765.29998779296875, "distance_right": 1.6201282395265412e-07, "index_right": 794, "nodeid": "1387101.400692_5862786.347674", "id": "1387101.400692_5862786.347674", "name": "manhole_787_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387101.400691983057186, 5862786.347674161195755 ] } }, -{ "type": "Feature", "properties": { "_index": 787, "bedlevel": 762.29998779296875, "branchid": "pipe_41_E22;pipe_41_E23", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_788_generated", "shape": null, "area": 0.64, "streetlevel": 765.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 765.29998779296875, "distance_right": 4.9157915962717621e-07, "index_right": 795, "nodeid": "1387124.783531_5862829.966972", "id": "1387124.783531_5862829.966972", "name": "manhole_788_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387124.783531384309754, 5862829.966971693560481 ] } }, -{ "type": "Feature", "properties": { "_index": 788, "bedlevel": 761.20001220703125, "branchid": "pipe_41_E23;pipe_41_E24", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_789_generated", "shape": null, "area": 0.64, "streetlevel": 764.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 764.20001220703125, "distance_right": 3.5598160791369735e-07, "index_right": 796, "nodeid": "1387148.551342_5862873.381911", "id": "1387148.551342_5862873.381911", "name": "manhole_789_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387148.551342260092497, 5862873.381910757161677 ] } }, -{ "type": "Feature", "properties": { "_index": 789, "bedlevel": 761.20001220703125, "branchid": "pipe_41_E24;pipe_41_E25", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_790_generated", "shape": null, "area": 0.64, "streetlevel": 764.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 764.20001220703125, "distance_right": 4.7576371253412377e-07, "index_right": 797, "nodeid": "1387176.029596_5862914.516765", "id": "1387176.029596_5862914.516765", "name": "manhole_790_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387176.029596295906231, 5862914.516764627769589 ] } }, -{ "type": "Feature", "properties": { "_index": 790, "bedlevel": 761.20001220703125, "branchid": "pipe_41_E25;pipe_41_E26", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_791_generated", "shape": null, "area": 0.64, "streetlevel": 764.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 764.20001220703125, "distance_right": 5.0580076725114359e-07, "index_right": 798, "nodeid": "1387204.050834_5862955.315436", "id": "1387204.050834_5862955.315436", "name": "manhole_791_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387204.050833505578339, 5862955.315435893833637 ] } }, -{ "type": "Feature", "properties": { "_index": 791, "bedlevel": 766.20001220703125, "branchid": "pipe_41_E26;pipe_41_E27", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_792_generated", "shape": null, "area": 0.64, "streetlevel": 769.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 769.20001220703125, "distance_right": 4.679884932996435e-07, "index_right": 799, "nodeid": "1387233.152246_5862995.351339", "id": "1387233.152246_5862995.351339", "name": "manhole_792_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387233.152246462181211, 5862995.351338926702738 ] } }, -{ "type": "Feature", "properties": { "_index": 792, "bedlevel": 769.70001220703125, "branchid": "pipe_41_E27;pipe_41_E28", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_793_generated", "shape": null, "area": 0.64, "streetlevel": 772.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 772.70001220703125, "distance_right": 4.2100416125757269e-07, "index_right": 800, "nodeid": "1387262.253659_5863035.387242", "id": "1387262.253659_5863035.387242", "name": "manhole_793_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387262.253659419016913, 5863035.387241959571838 ] } }, -{ "type": "Feature", "properties": { "_index": 793, "bedlevel": 769.70001220703125, "branchid": "pipe_41_E28;pipe_41_E29", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_794_generated", "shape": null, "area": 0.64, "streetlevel": 772.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 772.70001220703125, "distance_right": 2.2191985042402401e-07, "index_right": 801, "nodeid": "1387289.177212_5863076.714860", "id": "1387289.177212_5863076.714860", "name": "manhole_794_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387289.177211825968698, 5863076.714860137552023 ] } }, -{ "type": "Feature", "properties": { "_index": 794, "bedlevel": 769.70001220703125, "branchid": "pipe_41_E29;pipe_41_E30", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_795_generated", "shape": null, "area": 0.64, "streetlevel": 772.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 772.70001220703125, "distance_right": 3.2784018053457337e-07, "index_right": 802, "nodeid": "1387304.666786_5863123.392671", "id": "1387304.666786_5863123.392671", "name": "manhole_795_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387304.666786204557866, 5863123.392671256326139 ] } }, -{ "type": "Feature", "properties": { "_index": 795, "bedlevel": 759.0, "branchid": "pipe_41_E30;pipe_41_E31", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_796_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 5.8792503762199079e-07, "index_right": 803, "nodeid": "1387314.520281_5863171.895174", "id": "1387314.520281_5863171.895174", "name": "manhole_796_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387314.520281337434426, 5863171.895173518918455 ] } }, -{ "type": "Feature", "properties": { "_index": 796, "bedlevel": 774.10003662109375, "branchid": "pipe_41_E31;pipe_41_E32", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_797_generated", "shape": null, "area": 0.64, "streetlevel": 777.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 777.10003662109375, "distance_right": 4.4211253240860219e-07, "index_right": 804, "nodeid": "1387324.142221_5863220.446013", "id": "1387324.142221_5863220.446013", "name": "manhole_797_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387324.142220750683919, 5863220.446013364940882 ] } }, -{ "type": "Feature", "properties": { "_index": 797, "bedlevel": 777.4000244140625, "branchid": "pipe_41_E32;pipe_41_E33", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_798_generated", "shape": null, "area": 0.64, "streetlevel": 780.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 780.4000244140625, "distance_right": 2.666317529901308e-07, "index_right": 805, "nodeid": "1387333.764160_5863268.996853", "id": "1387333.764160_5863268.996853", "name": "manhole_798_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387333.764160163700581, 5863268.996853210031986 ] } }, -{ "type": "Feature", "properties": { "_index": 798, "bedlevel": 777.4000244140625, "branchid": "pipe_41_E33;pipe_41_E34", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_799_generated", "shape": null, "area": 0.64, "streetlevel": 780.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 780.4000244140625, "distance_right": 4.2683769428980457e-07, "index_right": 806, "nodeid": "1387343.386100_5863317.547693", "id": "1387343.386100_5863317.547693", "name": "manhole_799_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387343.386099576717243, 5863317.547693055123091 ] } }, -{ "type": "Feature", "properties": { "_index": 799, "bedlevel": 777.4000244140625, "branchid": "pipe_41_E34;pipe_41_E35", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_800_generated", "shape": null, "area": 0.64, "streetlevel": 780.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 780.4000244140625, "distance_right": 1.0017672039214415e-07, "index_right": 807, "nodeid": "1387353.008039_5863366.098533", "id": "1387353.008039_5863366.098533", "name": "manhole_800_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387353.008038989733905, 5863366.098532900214195 ] } }, -{ "type": "Feature", "properties": { "_index": 800, "bedlevel": 759.0, "branchid": "pipe_41_E35;pipe_41_E36", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_801_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 3.0672342309098305e-07, "index_right": 808, "nodeid": "1387364.066298_5863414.311535", "id": "1387364.066298_5863414.311535", "name": "manhole_801_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387364.066297837067395, 5863414.311534740030766 ] } }, -{ "type": "Feature", "properties": { "_index": 801, "bedlevel": 759.0, "branchid": "pipe_41_E36;pipe_41_E37", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_802_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 4.932537930056262e-07, "index_right": 809, "nodeid": "1387381.839410_5863460.427046", "id": "1387381.839410_5863460.427046", "name": "manhole_802_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387381.839409928303212, 5863460.427046488039196 ] } }, -{ "type": "Feature", "properties": { "_index": 802, "bedlevel": 759.0, "branchid": "pipe_41_E37;pipe_41_E38", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_803_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 1.9402170239574572e-07, "index_right": 810, "nodeid": "1387403.429579_5863504.961006", "id": "1387403.429579_5863504.961006", "name": "manhole_803_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387403.429578960640356, 5863504.96100580971688 ] } }, -{ "type": "Feature", "properties": { "_index": 803, "bedlevel": 759.0, "branchid": "pipe_41_E38;pipe_41_E39", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_804_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 2.8008674835213068e-07, "index_right": 811, "nodeid": "1387425.140453_5863549.440256", "id": "1387425.140453_5863549.440256", "name": "manhole_804_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387425.140452897874638, 5863549.440256260335445 ] } }, -{ "type": "Feature", "properties": { "_index": 804, "bedlevel": 759.0, "branchid": "pipe_41_E39;pipe_41_E40", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_805_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 3.3245607064712215e-07, "index_right": 812, "nodeid": "1387446.851327_5863593.919507", "id": "1387446.851327_5863593.919507", "name": "manhole_805_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387446.851326835108921, 5863593.91950671095401 ] } }, -{ "type": "Feature", "properties": { "_index": 805, "bedlevel": 759.0, "branchid": "pipe_41_E40;pipe_41_E41", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_806_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 4.0018657127822077e-07, "index_right": 813, "nodeid": "1387467.528696_5863638.888380", "id": "1387467.528696_5863638.888380", "name": "manhole_806_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387467.528695637593046, 5863638.888379830867052 ] } }, -{ "type": "Feature", "properties": { "_index": 806, "bedlevel": 771.5, "branchid": "pipe_41_E41;pipe_41_E42", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_807_generated", "shape": null, "area": 0.64, "streetlevel": 774.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 774.5, "distance_right": 2.3491677372957467e-08, "index_right": 814, "nodeid": "1387488.196078_5863683.861984", "id": "1387488.196078_5863683.861984", "name": "manhole_807_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387488.196078018052503, 5863683.861984014511108 ] } }, -{ "type": "Feature", "properties": { "_index": 807, "bedlevel": 759.0, "branchid": "pipe_41_E42;pipe_41_E43", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_808_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 4.8218551750434724e-07, "index_right": 815, "nodeid": "1387508.863468_5863728.835585", "id": "1387508.863468_5863728.835585", "name": "manhole_808_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387508.863468252588063, 5863728.835584589280188 ] } }, -{ "type": "Feature", "properties": { "_index": 808, "bedlevel": 759.0, "branchid": "pipe_41_E43;pipe_41_E44", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_809_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 1.1856933389495643e-07, "index_right": 816, "nodeid": "1387529.531309_5863773.808978", "id": "1387529.531309_5863773.808978", "name": "manhole_809_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387529.53130904212594, 5863773.808978110551834 ] } }, -{ "type": "Feature", "properties": { "_index": 809, "bedlevel": 759.0, "branchid": "pipe_41_E44;pipe_41_E45", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_810_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 4.2460196573060659e-07, "index_right": 817, "nodeid": "1387553.168003_5863817.173475", "id": "1387553.168003_5863817.173475", "name": "manhole_810_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387553.168002701364458, 5863817.17347530182451 ] } }, -{ "type": "Feature", "properties": { "_index": 810, "bedlevel": 759.0, "branchid": "pipe_41_E45;pipe_41_E46", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_811_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 3.185126609139896e-07, "index_right": 818, "nodeid": "1387579.562713_5863859.043334", "id": "1387579.562713_5863859.043334", "name": "manhole_811_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387579.562712850514799, 5863859.043333718553185 ] } }, -{ "type": "Feature", "properties": { "_index": 811, "bedlevel": 774.0, "branchid": "pipe_41_E46;pipe_41_E47", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_812_generated", "shape": null, "area": 0.64, "streetlevel": 777.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 777.0, "distance_right": 1.3597329523501825e-07, "index_right": 819, "nodeid": "1387605.957423_5863900.913192", "id": "1387605.957423_5863900.913192", "name": "manhole_812_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387605.957422999665141, 5863900.913192136213183 ] } }, -{ "type": "Feature", "properties": { "_index": 812, "bedlevel": 759.0, "branchid": "pipe_41_E47;pipe_41_E48", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_813_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 4.703326535743616e-07, "index_right": 820, "nodeid": "1387632.352133_5863942.783051", "id": "1387632.352133_5863942.783051", "name": "manhole_813_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387632.352133149048313, 5863942.783050553873181 ] } }, -{ "type": "Feature", "properties": { "_index": 813, "bedlevel": 759.0, "branchid": "pipe_41_E48;pipe_41_E49", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_814_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 2.9974130926166885e-07, "index_right": 821, "nodeid": "1387658.746843_5863984.652909", "id": "1387658.746843_5863984.652909", "name": "manhole_814_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387658.746843298198655, 5863984.652908970601857 ] } }, -{ "type": "Feature", "properties": { "_index": 814, "bedlevel": 759.0, "branchid": "pipe_41_E49;pipe_41_E50", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_815_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 4.8424206602011246e-07, "index_right": 822, "nodeid": "1387685.893106_5864026.029538", "id": "1387685.893106_5864026.029538", "name": "manhole_815_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387685.893106181640178, 5864026.029537551105022 ] } }, -{ "type": "Feature", "properties": { "_index": 815, "bedlevel": 759.0, "branchid": "pipe_41_E50;pipe_41_E51", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_816_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 1.1295166229046853e-07, "index_right": 823, "nodeid": "1387711.231137_5864068.427257", "id": "1387711.231137_5864068.427257", "name": "manhole_816_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387711.231136992340907, 5864068.42725711222738 ] } }, -{ "type": "Feature", "properties": { "_index": 816, "bedlevel": 759.0, "branchid": "pipe_41_E51;pipe_41_E52", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_817_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 4.1562063366879777e-07, "index_right": 824, "nodeid": "1387731.020947_5864113.414904", "id": "1387731.020947_5864113.414904", "name": "manhole_817_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387731.020947323646396, 5864113.414904261007905 ] } }, -{ "type": "Feature", "properties": { "_index": 817, "bedlevel": 759.0, "branchid": "pipe_41_E52;pipe_41_E53", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_818_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 5.0488384242805156e-07, "index_right": 825, "nodeid": "1387737.361907_5864162.342262", "id": "1387737.361907_5864162.342262", "name": "manhole_818_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387737.361907477490604, 5864162.342261835932732 ] } }, -{ "type": "Feature", "properties": { "_index": 818, "bedlevel": 759.0, "branchid": "pipe_41_E53;pipe_41_E54", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_819_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 3.9003768298900882e-07, "index_right": 826, "nodeid": "1387732.727566_5864211.475180", "id": "1387732.727566_5864211.475180", "name": "manhole_819_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387732.727565656881779, 5864211.475179814733565 ] } }, -{ "type": "Feature", "properties": { "_index": 819, "bedlevel": 759.0, "branchid": "pipe_41_E54;pipe_41_E55", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_820_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 5.2718950664228206e-07, "index_right": 827, "nodeid": "1387717.678849_5864258.627082", "id": "1387717.678849_5864258.627082", "name": "manhole_820_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387717.67884943424724, 5864258.627082298509777 ] } }, -{ "type": "Feature", "properties": { "_index": 820, "bedlevel": 759.0, "branchid": "pipe_41_E55;pipe_41_E56", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_821_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 2.4290664354722118e-07, "index_right": 828, "nodeid": "1387709.672104_5864307.231276", "id": "1387709.672104_5864307.231276", "name": "manhole_821_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387709.67210421175696, 5864307.23127611912787 ] } }, -{ "type": "Feature", "properties": { "_index": 821, "bedlevel": 765.0, "branchid": "pipe_41_E56;pipe_41_E57", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_822_generated", "shape": null, "area": 0.64, "streetlevel": 768.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 768.0, "distance_right": 1.5902605674469676e-07, "index_right": 829, "nodeid": "1387707.112881_5864356.660176", "id": "1387707.112881_5864356.660176", "name": "manhole_822_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387707.11288084089756, 5864356.66017600055784 ] } }, -{ "type": "Feature", "properties": { "_index": 822, "bedlevel": 765.0, "branchid": "pipe_41_E57;pipe_41_E58", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_823_generated", "shape": null, "area": 0.64, "streetlevel": 768.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 768.0, "distance_right": 1.7519326271547128e-07, "index_right": 830, "nodeid": "1387709.591798_5864406.012949", "id": "1387709.591798_5864406.012949", "name": "manhole_823_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387709.591797993984073, 5864406.012949175201356 ] } }, -{ "type": "Feature", "properties": { "_index": 823, "bedlevel": 765.0, "branchid": "pipe_41_E58;pipe_41_E59", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_824_generated", "shape": null, "area": 0.64, "streetlevel": 768.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 768.0, "distance_right": 3.1494439266847145e-07, "index_right": 831, "nodeid": "1387713.643261_5864455.341961", "id": "1387713.643261_5864455.341961", "name": "manhole_824_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387713.643261310644448, 5864455.341961052268744 ] } }, -{ "type": "Feature", "properties": { "_index": 824, "bedlevel": 774.20001220703125, "branchid": "pipe_41_E59;pipe_41_E60", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_825_generated", "shape": null, "area": 0.64, "streetlevel": 777.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 777.20001220703125, "distance_right": 3.3700013852472541e-07, "index_right": 832, "nodeid": "1387715.877522_5864504.642318", "id": "1387715.877522_5864504.642318", "name": "manhole_825_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387715.877521668095142, 5864504.642317942343652 ] } }, -{ "type": "Feature", "properties": { "_index": 825, "bedlevel": 774.20001220703125, "branchid": "pipe_41_E60;pipe_41_E61", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_826_generated", "shape": null, "area": 0.64, "streetlevel": 777.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 777.20001220703125, "distance_right": 4.8866509689768297e-07, "index_right": 833, "nodeid": "1387708.680233_5864553.426558", "id": "1387708.680233_5864553.426558", "name": "manhole_826_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387708.68023270717822, 5864553.426558391191065 ] } }, -{ "type": "Feature", "properties": { "_index": 826, "bedlevel": 774.20001220703125, "branchid": "pipe_41_E61;pipe_41_E62", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_827_generated", "shape": null, "area": 0.64, "streetlevel": 777.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 777.20001220703125, "distance_right": 3.4967976999271033e-07, "index_right": 834, "nodeid": "1387690.790251_5864599.575386", "id": "1387690.790251_5864599.575386", "name": "manhole_827_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387690.790250770282, 5864599.575386263430119 ] } }, -{ "type": "Feature", "properties": { "_index": 827, "bedlevel": 807.60003662109375, "branchid": "pipe_41_E62;pipe_41_E63", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_828_generated", "shape": null, "area": 0.64, "streetlevel": 810.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 810.60003662109375, "distance_right": 2.1553742732443595e-07, "index_right": 835, "nodeid": "1387672.900269_5864645.724214", "id": "1387672.900269_5864645.724214", "name": "manhole_828_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387672.900268833618611, 5864645.724214136600494 ] } }, -{ "type": "Feature", "properties": { "_index": 828, "bedlevel": 807.60003662109375, "branchid": "pipe_41_E63;pipe_41_E64", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_829_generated", "shape": null, "area": 0.64, "streetlevel": 810.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 810.60003662109375, "distance_right": 5.0501138359744414e-07, "index_right": 836, "nodeid": "1387659.931900_5864692.983886", "id": "1387659.931900_5864692.983886", "name": "manhole_829_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387659.931900478899479, 5864692.98388583958149 ] } }, -{ "type": "Feature", "properties": { "_index": 829, "bedlevel": 807.60003662109375, "branchid": "pipe_41_E64;pipe_41_E65", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_830_generated", "shape": null, "area": 0.64, "streetlevel": 810.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 810.60003662109375, "distance_right": 4.453007647556389e-07, "index_right": 837, "nodeid": "1387659.223570_5864742.029465", "id": "1387659.223570_5864742.029465", "name": "manhole_830_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387659.223570322152227, 5864742.029465307481587 ] } }, -{ "type": "Feature", "properties": { "_index": 830, "bedlevel": 806.60003662109375, "branchid": "pipe_41_E65;pipe_41_E66", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_831_generated", "shape": null, "area": 0.64, "streetlevel": 809.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 809.60003662109375, "distance_right": 4.9934199741603634e-07, "index_right": 838, "nodeid": "1387675.926897_5864788.273514", "id": "1387675.926897_5864788.273514", "name": "manhole_831_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387675.926896508783102, 5864788.273513910360634 ] } }, -{ "type": "Feature", "properties": { "_index": 831, "bedlevel": 771.10003662109375, "branchid": "pipe_41_E66;pipe_41_E67", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_832_generated", "shape": null, "area": 0.64, "streetlevel": 774.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 774.10003662109375, "distance_right": 4.9261335667974956e-07, "index_right": 839, "nodeid": "1387702.296292_5864830.159320", "id": "1387702.296292_5864830.159320", "name": "manhole_832_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387702.296291569946334, 5864830.159320239908993 ] } }, -{ "type": "Feature", "properties": { "_index": 832, "bedlevel": 771.10003662109375, "branchid": "pipe_41_E67;pipe_41_E68", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_833_generated", "shape": null, "area": 0.64, "streetlevel": 774.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 774.10003662109375, "distance_right": 5.6685196386871291e-07, "index_right": 840, "nodeid": "1387728.665687_5864872.045127", "id": "1387728.665687_5864872.045127", "name": "manhole_833_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387728.665686630876735, 5864872.045126569457352 ] } }, -{ "type": "Feature", "properties": { "_index": 833, "bedlevel": 779.5, "branchid": "pipe_41_E68;pipe_41_E69", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_834_generated", "shape": null, "area": 0.64, "streetlevel": 782.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 782.5, "distance_right": 3.260812906289786e-07, "index_right": 841, "nodeid": "1387751.608185_5864915.528789", "id": "1387751.608185_5864915.528789", "name": "manhole_834_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387751.608185108983889, 5864915.528788692317903 ] } }, -{ "type": "Feature", "properties": { "_index": 834, "bedlevel": 779.5, "branchid": "pipe_41_E69;pipe_41_E70", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_835_generated", "shape": null, "area": 0.64, "streetlevel": 782.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 782.5, "distance_right": 5.9259639011965048e-07, "index_right": 842, "nodeid": "1387766.741665_5864962.653555", "id": "1387766.741665_5864962.653555", "name": "manhole_835_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387766.741664502769709, 5864962.653554677963257 ] } }, -{ "type": "Feature", "properties": { "_index": 835, "bedlevel": 779.5, "branchid": "pipe_41_E70;pipe_41_E71", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_836_generated", "shape": null, "area": 0.64, "streetlevel": 782.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 782.5, "distance_right": 4.9711278093853967e-07, "index_right": 843, "nodeid": "1387778.991920_5865010.246724", "id": "1387778.991920_5865010.246724", "name": "manhole_836_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387778.99191950308159, 5865010.246724016033113 ] } }, -{ "type": "Feature", "properties": { "_index": 836, "bedlevel": 817.20001220703125, "branchid": "pipe_41_E71;pipe_41_E72", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_837_generated", "shape": null, "area": 0.64, "streetlevel": 820.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 820.20001220703125, "distance_right": 2.7262320916715243e-07, "index_right": 844, "nodeid": "1387779.554608_5865059.738634", "id": "1387779.554608_5865059.738634", "name": "manhole_837_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387779.554608268430457, 5865059.738633952103555 ] } }, -{ "type": "Feature", "properties": { "_index": 837, "bedlevel": 817.20001220703125, "branchid": "pipe_41_E72;pipe_41_E73", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_838_generated", "shape": null, "area": 0.64, "streetlevel": 820.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 820.20001220703125, "distance_right": 1.176384747423801e-07, "index_right": 845, "nodeid": "1387780.117297_5865109.230544", "id": "1387780.117297_5865109.230544", "name": "manhole_838_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387780.117297033779323, 5865109.230543887242675 ] } }, -{ "type": "Feature", "properties": { "_index": 838, "bedlevel": 831.60003662109375, "branchid": "pipe_41_E73;pipe_41_E74", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_839_generated", "shape": null, "area": 0.64, "streetlevel": 834.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 834.60003662109375, "distance_right": 2.5451201057427246e-07, "index_right": 846, "nodeid": "1387782.917817_5865158.566991", "id": "1387782.917817_5865158.566991", "name": "manhole_839_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387782.917817069217563, 5865158.566991245374084 ] } }, -{ "type": "Feature", "properties": { "_index": 839, "bedlevel": 806.60003662109375, "branchid": "pipe_41_E74;pipe_41_E75", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_840_generated", "shape": null, "area": 0.64, "streetlevel": 809.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 809.60003662109375, "distance_right": 3.8381515451147322e-07, "index_right": 847, "nodeid": "1387789.203932_5865207.661294", "id": "1387789.203932_5865207.661294", "name": "manhole_840_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387789.203931836877018, 5865207.661293652839959 ] } }, -{ "type": "Feature", "properties": { "_index": 840, "bedlevel": 806.60003662109375, "branchid": "pipe_41_E75;pipe_41_E76", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_841_generated", "shape": null, "area": 0.64, "streetlevel": 809.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 809.60003662109375, "distance_right": 3.9995425409532255e-07, "index_right": 848, "nodeid": "1387795.490047_5865256.755596", "id": "1387795.490047_5865256.755596", "name": "manhole_841_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387795.490046604769304, 5865256.755596060305834 ] } }, -{ "type": "Feature", "properties": { "_index": 841, "bedlevel": 808.60003662109375, "branchid": "pipe_41_E76;pipe_41_E77", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_842_generated", "shape": null, "area": 0.64, "streetlevel": 811.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 811.60003662109375, "distance_right": 4.8361564557877265e-07, "index_right": 849, "nodeid": "1387804.549935_5865305.332480", "id": "1387804.549935_5865305.332480", "name": "manhole_842_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387804.549934879876673, 5865305.332479531876743 ] } }, -{ "type": "Feature", "properties": { "_index": 842, "bedlevel": 808.60003662109375, "branchid": "pipe_41_E77;pipe_41_E78", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_843_generated", "shape": null, "area": 0.64, "streetlevel": 811.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 811.60003662109375, "distance_right": 3.9649035137181816e-07, "index_right": 850, "nodeid": "1387816.386747_5865353.391356", "id": "1387816.386747_5865353.391356", "name": "manhole_843_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387816.386747075244784, 5865353.391356389038265 ] } }, -{ "type": "Feature", "properties": { "_index": 843, "bedlevel": 808.60003662109375, "branchid": "pipe_41_E78;pipe_41_E79", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_844_generated", "shape": null, "area": 0.64, "streetlevel": 811.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 811.60003662109375, "distance_right": 3.6575204182979905e-07, "index_right": 851, "nodeid": "1387828.223559_5865401.450233", "id": "1387828.223559_5865401.450233", "name": "manhole_844_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387828.223559270845726, 5865401.450233246199787 ] } }, -{ "type": "Feature", "properties": { "_index": 844, "bedlevel": 799.5, "branchid": "pipe_41_E79;pipe_41_E80", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_845_generated", "shape": null, "area": 0.64, "streetlevel": 802.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 802.5, "distance_right": 5.0071148835204541e-07, "index_right": 852, "nodeid": "1387842.966275_5865448.679594", "id": "1387842.966275_5865448.679594", "name": "manhole_845_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387842.96627543354407, 5865448.679594250395894 ] } }, -{ "type": "Feature", "properties": { "_index": 845, "bedlevel": 799.5, "branchid": "pipe_41_E80;pipe_41_E81", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_846_generated", "shape": null, "area": 0.64, "streetlevel": 802.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 802.5, "distance_right": 2.0659636486342148e-07, "index_right": 853, "nodeid": "1387858.283513_5865495.744953", "id": "1387858.283513_5865495.744953", "name": "manhole_846_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387858.283513206522912, 5865495.744953005574644 ] } }, -{ "type": "Feature", "properties": { "_index": 846, "bedlevel": 799.5, "branchid": "pipe_41_E81;pipe_41_E82", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_847_generated", "shape": null, "area": 0.64, "streetlevel": 802.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 802.5, "distance_right": 4.9802795784708347e-07, "index_right": 854, "nodeid": "1387872.788358_5865543.026506", "id": "1387872.788358_5865543.026506", "name": "manhole_847_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387872.788357679266483, 5865543.026506381109357 ] } }, -{ "type": "Feature", "properties": { "_index": 847, "bedlevel": 775.20001220703125, "branchid": "pipe_41_E82;pipe_41_E83", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_848_generated", "shape": null, "area": 0.64, "streetlevel": 778.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 778.20001220703125, "distance_right": 3.0259537908334364e-07, "index_right": 855, "nodeid": "1387882.890575_5865591.479690", "id": "1387882.890575_5865591.479690", "name": "manhole_848_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387882.890574953285977, 5865591.479689701460302 ] } }, -{ "type": "Feature", "properties": { "_index": 848, "bedlevel": 775.20001220703125, "branchid": "pipe_41_E83;pipe_41_E84", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_849_generated", "shape": null, "area": 0.64, "streetlevel": 778.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 778.20001220703125, "distance_right": 2.2833932818058066e-07, "index_right": 856, "nodeid": "1387892.992792_5865639.932873", "id": "1387892.992792_5865639.932873", "name": "manhole_849_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387892.992792227305472, 5865639.932873022742569 ] } }, -{ "type": "Feature", "properties": { "_index": 849, "bedlevel": 775.20001220703125, "branchid": "pipe_41_E84;pipe_41_E85", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_850_generated", "shape": null, "area": 0.64, "streetlevel": 778.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 778.20001220703125, "distance_right": 6.0513342729627048e-07, "index_right": 857, "nodeid": "1387903.095010_5865688.386056", "id": "1387903.095010_5865688.386056", "name": "manhole_850_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387903.095009501324967, 5865688.386056343093514 ] } }, -{ "type": "Feature", "properties": { "_index": 850, "bedlevel": 791.70001220703125, "branchid": "pipe_41_E85;pipe_50_E0;pipe_51_E12", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_851_generated", "shape": null, "area": 0.64, "streetlevel": 794.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 794.70001220703125, "distance_right": 4.0437267150492186e-07, "index_right": 858, "nodeid": "1387913.197227_5865736.839240", "id": "1387913.197227_5865736.839240", "name": "manhole_851_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387913.197226775344461, 5865736.839239663444459 ] } }, -{ "type": "Feature", "properties": { "_index": 851, "bedlevel": 827.9000244140625, "branchid": "pipe_42_E0;pipe_43_E1;pipe_44_E0", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_852_generated", "shape": null, "area": 0.64, "streetlevel": 830.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 830.9000244140625, "distance_right": 5.215972352701414e-07, "index_right": 859, "nodeid": "1387767.438602_5866395.894651", "id": "1387767.438602_5866395.894651", "name": "manhole_852_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387767.438602478476241, 5866395.894650792703032 ] } }, -{ "type": "Feature", "properties": { "_index": 851, "bedlevel": 827.9000244140625, "branchid": "pipe_42_E0;pipe_42_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_853_generated", "shape": null, "area": 0.64, "streetlevel": 830.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 830.9000244140625, "distance_right": 1.7080837506054717e-07, "index_right": 860, "nodeid": "1387758.181959_5866444.388787", "id": "1387758.181959_5866444.388787", "name": "manhole_853_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387758.181959156645462, 5866444.388786932453513 ] } }, -{ "type": "Feature", "properties": { "_index": 852, "bedlevel": 827.9000244140625, "branchid": "pipe_42_E1;pipe_42_E2", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_854_generated", "shape": null, "area": 0.64, "streetlevel": 830.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 830.9000244140625, "distance_right": 1.7976697036433568e-07, "index_right": 861, "nodeid": "1387748.925316_5866492.882923", "id": "1387748.925316_5866492.882923", "name": "manhole_854_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387748.925315835047513, 5866492.882923071272671 ] } }, -{ "type": "Feature", "properties": { "_index": 853, "bedlevel": 813.5, "branchid": "pipe_42_E2;pipe_42_E3", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_855_generated", "shape": null, "area": 0.64, "streetlevel": 816.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 816.5, "distance_right": 5.3076935757696028e-07, "index_right": 862, "nodeid": "1387739.668673_5866541.377059", "id": "1387739.668673_5866541.377059", "name": "manhole_855_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387739.668672513216734, 5866541.377059211023152 ] } }, -{ "type": "Feature", "properties": { "_index": 854, "bedlevel": 813.5, "branchid": "pipe_42_E3;pipe_42_E4", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_856_generated", "shape": null, "area": 0.64, "streetlevel": 816.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 816.5, "distance_right": 3.9917691783746745e-07, "index_right": 863, "nodeid": "1387730.412029_5866589.871195", "id": "1387730.412029_5866589.871195", "name": "manhole_856_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387730.412029191618785, 5866589.87119534984231 ] } }, -{ "type": "Feature", "properties": { "_index": 855, "bedlevel": 813.10003662109375, "branchid": "pipe_42_E4;pipe_42_E5", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_857_generated", "shape": null, "area": 0.64, "streetlevel": 816.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 816.10003662109375, "distance_right": 5.0687060002795753e-07, "index_right": 864, "nodeid": "1387721.155386_5866638.365331", "id": "1387721.155386_5866638.365331", "name": "manhole_857_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387721.155385869788006, 5866638.365331489592791 ] } }, -{ "type": "Feature", "properties": { "_index": 856, "bedlevel": 813.10003662109375, "branchid": "pipe_42_E5;pipe_42_E6", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_858_generated", "shape": null, "area": 0.64, "streetlevel": 816.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 816.10003662109375, "distance_right": 5.9584928216719691e-07, "index_right": 865, "nodeid": "1387711.868743_5866686.853722", "id": "1387711.868743_5866686.853722", "name": "manhole_858_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387711.868742506252602, 5866686.853722332976758 ] } }, -{ "type": "Feature", "properties": { "_index": 857, "bedlevel": 813.10003662109375, "branchid": "pipe_42_E6;pipe_42_E7", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_859_generated", "shape": null, "area": 0.64, "streetlevel": 816.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 816.10003662109375, "distance_right": 5.7928339006193113e-07, "index_right": 866, "nodeid": "1387702.553355_5866735.336608", "id": "1387702.553355_5866735.336608", "name": "manhole_859_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387702.553355348296463, 5866735.336608462966979 ] } }, -{ "type": "Feature", "properties": { "_index": 858, "bedlevel": 799.4000244140625, "branchid": "pipe_42_E7", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_860_generated", "shape": null, "area": 0.64, "streetlevel": 802.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 802.4000244140625, "distance_right": 4.9781434926194598e-07, "index_right": 867, "nodeid": "1387692.161796_5866783.420620", "id": "1387692.161796_5866783.420620", "name": "manhole_860_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387692.161796326050535, 5866783.420620376244187 ] } }, -{ "type": "Feature", "properties": { "_index": 859, "bedlevel": 803.20001220703125, "branchid": "pipe_43_E0;pipe_45_E3;pipe_46_E4", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_861_generated", "shape": null, "area": 0.64, "streetlevel": 806.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 806.20001220703125, "distance_right": 5.3089394760884435e-07, "index_right": 868, "nodeid": "1387809.534625_5866309.639252", "id": "1387809.534625_5866309.639252", "name": "manhole_861_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387809.534624515566975, 5866309.639251782558858 ] } }, -{ "type": "Feature", "properties": { "_index": 859, "bedlevel": 803.20001220703125, "branchid": "pipe_43_E0;pipe_43_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_862_generated", "shape": null, "area": 0.64, "streetlevel": 806.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 806.20001220703125, "distance_right": 5.7391922453984659e-07, "index_right": 869, "nodeid": "1387788.486613_5866352.766951", "id": "1387788.486613_5866352.766951", "name": "manhole_862_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387788.486613497138023, 5866352.766951287165284 ] } }, -{ "type": "Feature", "properties": { "_index": 861, "bedlevel": 837.10003662109375, "branchid": "pipe_44_E0;pipe_44_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_863_generated", "shape": null, "area": 0.64, "streetlevel": 840.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 840.10003662109375, "distance_right": 4.8732610625475058e-07, "index_right": 870, "nodeid": "1387774.733068_5866351.644692", "id": "1387774.733068_5866351.644692", "name": "manhole_863_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387774.73306847945787, 5866351.644692087545991 ] } }, -{ "type": "Feature", "properties": { "_index": 862, "bedlevel": 803.20001220703125, "branchid": "pipe_44_E1;pipe_44_E2", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_864_generated", "shape": null, "area": 0.64, "streetlevel": 806.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 806.20001220703125, "distance_right": 2.4437958040221395e-07, "index_right": 871, "nodeid": "1387787.219046_5866308.756402", "id": "1387787.219046_5866308.756402", "name": "manhole_864_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387787.219046234386042, 5866308.756401930935681 ] } }, -{ "type": "Feature", "properties": { "_index": 863, "bedlevel": 803.20001220703125, "branchid": "pipe_44_E2;pipe_44_E3", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_865_generated", "shape": null, "area": 0.64, "streetlevel": 806.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 806.20001220703125, "distance_right": 3.3154241596590628e-07, "index_right": 872, "nodeid": "1387802.581936_5866266.622690", "id": "1387802.581936_5866266.622690", "name": "manhole_865_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387802.581935805035755, 5866266.622689731419086 ] } }, -{ "type": "Feature", "properties": { "_index": 864, "bedlevel": 824.70001220703125, "branchid": "pipe_44_E3;pipe_44_E4", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_866_generated", "shape": null, "area": 0.64, "streetlevel": 827.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 827.70001220703125, "distance_right": 4.2553696916372962e-07, "index_right": 873, "nodeid": "1387818.989884_5866224.886323", "id": "1387818.989884_5866224.886323", "name": "manhole_866_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387818.989883717847988, 5866224.886323318816721 ] } }, -{ "type": "Feature", "properties": { "_index": 865, "bedlevel": 824.70001220703125, "branchid": "pipe_44_E4;pipe_44_E5", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_867_generated", "shape": null, "area": 0.64, "streetlevel": 827.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 827.70001220703125, "distance_right": 2.2789743614175487e-07, "index_right": 874, "nodeid": "1387838.767448_5866184.784888", "id": "1387838.767448_5866184.784888", "name": "manhole_867_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387838.767447788733989, 5866184.784887914545834 ] } }, -{ "type": "Feature", "properties": { "_index": 866, "bedlevel": 824.70001220703125, "branchid": "pipe_44_E5;pipe_44_E6", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_868_generated", "shape": null, "area": 0.64, "streetlevel": 827.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 827.70001220703125, "distance_right": 5.9797237451900057e-07, "index_right": 875, "nodeid": "1387862.375428_5866146.679680", "id": "1387862.375428_5866146.679680", "name": "manhole_868_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387862.375427621416748, 5866146.679679537191987 ] } }, -{ "type": "Feature", "properties": { "_index": 867, "bedlevel": 800.9000244140625, "branchid": "pipe_44_E6;pipe_44_E7", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_869_generated", "shape": null, "area": 0.64, "streetlevel": 803.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 803.9000244140625, "distance_right": 3.6638230381293925e-07, "index_right": 876, "nodeid": "1387890.316308_5866111.904927", "id": "1387890.316308_5866111.904927", "name": "manhole_869_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387890.316308293025941, 5866111.904927220195532 ] } }, -{ "type": "Feature", "properties": { "_index": 868, "bedlevel": 800.9000244140625, "branchid": "pipe_44_E7;pipe_46_E0;pipe_47_E5;pipe_48_E0", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_870_generated", "shape": null, "area": 0.64, "streetlevel": 803.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 803.9000244140625, "distance_right": 3.1534587877498962e-07, "index_right": 877, "nodeid": "1387932.086586_5866099.149365", "id": "1387932.086586_5866099.149365", "name": "manhole_870_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387932.086585889104754, 5866099.149365295656025 ] } }, -{ "type": "Feature", "properties": { "_index": 869, "bedlevel": 800.9000244140625, "branchid": "pipe_45_E0", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_871_generated", "shape": null, "area": 0.64, "streetlevel": 803.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 803.9000244140625, "distance_right": 6.266084733821659e-07, "index_right": 878, "nodeid": "1387931.614703_5866170.542120", "id": "1387931.614703_5866170.542120", "name": "manhole_871_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387931.614702571649104, 5866170.542120457626879 ] } }, -{ "type": "Feature", "properties": { "_index": 869, "bedlevel": 800.9000244140625, "branchid": "pipe_45_E0;pipe_45_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_872_generated", "shape": null, "area": 0.64, "streetlevel": 803.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 803.9000244140625, "distance_right": 5.3846575384340826e-07, "index_right": 879, "nodeid": "1387899.497388_5866203.806989", "id": "1387899.497388_5866203.806989", "name": "manhole_872_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387899.497387683717534, 5866203.806988564319909 ] } }, -{ "type": "Feature", "properties": { "_index": 870, "bedlevel": 803.20001220703125, "branchid": "pipe_45_E1;pipe_45_E2", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_873_generated", "shape": null, "area": 0.64, "streetlevel": 806.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 806.20001220703125, "distance_right": 3.6531595428320365e-07, "index_right": 880, "nodeid": "1387869.509800_5866239.084410", "id": "1387869.509800_5866239.084410", "name": "manhole_873_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387869.509799961000681, 5866239.084409636445343 ] } }, -{ "type": "Feature", "properties": { "_index": 871, "bedlevel": 803.20001220703125, "branchid": "pipe_45_E2;pipe_45_E3", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_874_generated", "shape": null, "area": 0.64, "streetlevel": 806.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 806.20001220703125, "distance_right": 3.7571919273733843e-07, "index_right": 881, "nodeid": "1387839.522212_5866274.361831", "id": "1387839.522212_5866274.361831", "name": "manhole_874_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387839.522212238283828, 5866274.361830709502101 ] } }, -{ "type": "Feature", "properties": { "_index": 873, "bedlevel": 800.9000244140625, "branchid": "pipe_46_E0;pipe_46_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_875_generated", "shape": null, "area": 0.64, "streetlevel": 803.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 803.9000244140625, "distance_right": 6.1718976969024423e-07, "index_right": 882, "nodeid": "1387908.367354_5866141.903963", "id": "1387908.367354_5866141.903963", "name": "manhole_875_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387908.367353544337675, 5866141.903963415883482 ] } }, -{ "type": "Feature", "properties": { "_index": 874, "bedlevel": 800.9000244140625, "branchid": "pipe_46_E1;pipe_46_E2", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_876_generated", "shape": null, "area": 0.64, "streetlevel": 803.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 803.9000244140625, "distance_right": 4.9858174847585437e-07, "index_right": 883, "nodeid": "1387876.955023_5866179.987773", "id": "1387876.955023_5866179.987773", "name": "manhole_876_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387876.955022902460769, 5866179.987773489207029 ] } }, -{ "type": "Feature", "properties": { "_index": 875, "bedlevel": 824.70001220703125, "branchid": "pipe_46_E2;pipe_46_E3", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_877_generated", "shape": null, "area": 0.64, "streetlevel": 827.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 827.70001220703125, "distance_right": 1.876529768744179e-07, "index_right": 884, "nodeid": "1387847.458594_5866219.470103", "id": "1387847.458594_5866219.470103", "name": "manhole_877_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387847.458594153402373, 5866219.470102892257273 ] } }, -{ "type": "Feature", "properties": { "_index": 876, "bedlevel": 803.20001220703125, "branchid": "pipe_46_E3;pipe_46_E4", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_878_generated", "shape": null, "area": 0.64, "streetlevel": 806.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 806.20001220703125, "distance_right": 4.6156036966779148e-07, "index_right": 885, "nodeid": "1387823.639856_5866262.662998", "id": "1387823.639856_5866262.662998", "name": "manhole_878_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387823.639855962945148, 5866262.662997540086508 ] } }, -{ "type": "Feature", "properties": { "_index": 878, "bedlevel": 801.4000244140625, "branchid": "pipe_47_E0", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_879_generated", "shape": null, "area": 0.64, "streetlevel": 804.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 804.4000244140625, "distance_right": 2.7377250423463006e-07, "index_right": 886, "nodeid": "1387940.443674_5865845.093255", "id": "1387940.443674_5865845.093255", "name": "manhole_879_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387940.443674022099003, 5865845.093254727311432 ] } }, -{ "type": "Feature", "properties": { "_index": 878, "bedlevel": 801.4000244140625, "branchid": "pipe_47_E0;pipe_47_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_880_generated", "shape": null, "area": 0.64, "streetlevel": 804.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 804.4000244140625, "distance_right": 3.2059452282998279e-07, "index_right": 887, "nodeid": "1387943.318034_5865887.628140", "id": "1387943.318034_5865887.628140", "name": "manhole_880_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387943.318034203490242, 5865887.628139751963317 ] } }, -{ "type": "Feature", "properties": { "_index": 879, "bedlevel": 801.4000244140625, "branchid": "pipe_47_E1;pipe_47_E2", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_881_generated", "shape": null, "area": 0.64, "streetlevel": 804.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 804.4000244140625, "distance_right": 3.9845922374459836e-07, "index_right": 888, "nodeid": "1387946.009428_5865930.175073", "id": "1387946.009428_5865930.175073", "name": "manhole_881_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387946.009428307646886, 5865930.175072746351361 ] } }, -{ "type": "Feature", "properties": { "_index": 880, "bedlevel": 813.70001220703125, "branchid": "pipe_47_E2;pipe_47_E3", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_882_generated", "shape": null, "area": 0.64, "streetlevel": 816.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 816.70001220703125, "distance_right": 4.8718698089721897e-07, "index_right": 889, "nodeid": "1387948.700822_5865972.722006", "id": "1387948.700822_5865972.722006", "name": "manhole_882_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387948.700822412036359, 5865972.722005739808083 ] } }, -{ "type": "Feature", "properties": { "_index": 881, "bedlevel": 813.70001220703125, "branchid": "pipe_47_E3;pipe_47_E4", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_883_generated", "shape": null, "area": 0.64, "streetlevel": 816.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 816.70001220703125, "distance_right": 5.8533091283838573e-07, "index_right": 890, "nodeid": "1387944.872251_5866015.105106", "id": "1387944.872251_5866015.105106", "name": "manhole_883_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387944.872250664513558, 5866015.105105520226061 ] } }, -{ "type": "Feature", "properties": { "_index": 882, "bedlevel": 813.70001220703125, "branchid": "pipe_47_E4;pipe_47_E5", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_884_generated", "shape": null, "area": 0.64, "streetlevel": 816.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 816.70001220703125, "distance_right": 1.8278199108301624e-07, "index_right": 891, "nodeid": "1387940.047370_5866057.463170", "id": "1387940.047370_5866057.463170", "name": "manhole_884_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387940.047370131826028, 5866057.463170127011836 ] } }, -{ "type": "Feature", "properties": { "_index": 884, "bedlevel": 783.29998779296875, "branchid": "pipe_48_E0", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_885_generated", "shape": null, "area": 0.64, "streetlevel": 786.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 786.29998779296875, "distance_right": 5.3234291644079913e-07, "index_right": 892, "nodeid": "1387975.279995_5866107.425722", "id": "1387975.279995_5866107.425722", "name": "manhole_885_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387975.279995472636074, 5866107.425722245126963 ] } }, -{ "type": "Feature", "properties": { "_index": 885, "bedlevel": 906.5, "branchid": "pipe_49_E125", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_886_generated", "shape": null, "area": 0.64, "streetlevel": 909.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 909.5, "distance_right": 2.3433279429140186e-07, "index_right": 893, "nodeid": "1392926.966795_5866808.501405", "id": "1392926.966795_5866808.501405", "name": "manhole_886_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392926.966794768813998, 5866808.501405037939548 ] } }, -{ "type": "Feature", "properties": { "_index": 885, "bedlevel": 907.4000244140625, "branchid": "pipe_49_E125;pipe_49_E126", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_887_generated", "shape": null, "area": 0.64, "streetlevel": 910.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 910.4000244140625, "distance_right": 2.711877368400116e-07, "index_right": 894, "nodeid": "1392879.417932_5866793.491589", "id": "1392879.417932_5866793.491589", "name": "manhole_887_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392879.417931769276038, 5866793.491589142940938 ] } }, -{ "type": "Feature", "properties": { "_index": 886, "bedlevel": 907.4000244140625, "branchid": "pipe_49_E126;pipe_49_E127", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_888_generated", "shape": null, "area": 0.64, "streetlevel": 910.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 910.4000244140625, "distance_right": 3.3822343619387493e-07, "index_right": 895, "nodeid": "1392831.869069_5866778.481773", "id": "1392831.869069_5866778.481773", "name": "manhole_888_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392831.869068769738078, 5866778.481773247942328 ] } }, -{ "type": "Feature", "properties": { "_index": 887, "bedlevel": 862.0, "branchid": "pipe_49_E127;pipe_49_E128", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_889_generated", "shape": null, "area": 0.64, "streetlevel": 865.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 865.0, "distance_right": 4.2118703056337554e-07, "index_right": 896, "nodeid": "1392784.320206_5866763.471957", "id": "1392784.320206_5866763.471957", "name": "manhole_889_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392784.320205770200118, 5866763.471957352943718 ] } }, -{ "type": "Feature", "properties": { "_index": 888, "bedlevel": 862.0, "branchid": "pipe_49_E128;pipe_49_E129", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_890_generated", "shape": null, "area": 0.64, "streetlevel": 865.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 865.0, "distance_right": 5.1250356341054922e-07, "index_right": 897, "nodeid": "1392736.771343_5866748.462141", "id": "1392736.771343_5866748.462141", "name": "manhole_890_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392736.771342770429328, 5866748.462141457945108 ] } }, -{ "type": "Feature", "properties": { "_index": 889, "bedlevel": 875.4000244140625, "branchid": "pipe_49_E129;pipe_49_E130", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_891_generated", "shape": null, "area": 0.64, "streetlevel": 878.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 878.4000244140625, "distance_right": 4.9322917410243842e-07, "index_right": 898, "nodeid": "1392689.222480_5866733.452326", "id": "1392689.222480_5866733.452326", "name": "manhole_891_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392689.222479770891368, 5866733.452325562946498 ] } }, -{ "type": "Feature", "properties": { "_index": 890, "bedlevel": 875.4000244140625, "branchid": "pipe_49_E130;pipe_49_E131", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_892_generated", "shape": null, "area": 0.64, "streetlevel": 878.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 878.4000244140625, "distance_right": 4.035102166412638e-07, "index_right": 899, "nodeid": "1392641.673617_5866718.442510", "id": "1392641.673617_5866718.442510", "name": "manhole_892_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392641.673616771353409, 5866718.442509667947888 ] } }, -{ "type": "Feature", "properties": { "_index": 891, "bedlevel": 901.9000244140625, "branchid": "pipe_49_E131;pipe_49_E132", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_893_generated", "shape": null, "area": 0.64, "streetlevel": 904.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 904.9000244140625, "distance_right": 3.2137241883713538e-07, "index_right": 900, "nodeid": "1392594.124754_5866703.432694", "id": "1392594.124754_5866703.432694", "name": "manhole_893_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392594.124753771815449, 5866703.432693773880601 ] } }, -{ "type": "Feature", "properties": { "_index": 892, "bedlevel": 901.9000244140625, "branchid": "pipe_49_E132;pipe_49_E133", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_894_generated", "shape": null, "area": 0.64, "streetlevel": 904.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 904.9000244140625, "distance_right": 2.5789438712268496e-07, "index_right": 901, "nodeid": "1392546.575891_5866688.422878", "id": "1392546.575891_5866688.422878", "name": "manhole_894_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392546.575890772277489, 5866688.422877878881991 ] } }, -{ "type": "Feature", "properties": { "_index": 893, "bedlevel": 928.5, "branchid": "pipe_49_E133;pipe_49_E134", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_895_generated", "shape": null, "area": 0.64, "streetlevel": 931.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 931.5, "distance_right": 2.2779358194461109e-07, "index_right": 902, "nodeid": "1392499.027028_5866673.413062", "id": "1392499.027028_5866673.413062", "name": "manhole_895_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392499.02702777273953, 5866673.413061983883381 ] } }, -{ "type": "Feature", "properties": { "_index": 894, "bedlevel": 928.5, "branchid": "pipe_49_E134;pipe_49_E135", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_896_generated", "shape": null, "area": 0.64, "streetlevel": 931.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 931.5, "distance_right": 2.434250781957115e-07, "index_right": 903, "nodeid": "1392451.478165_5866658.403246", "id": "1392451.478165_5866658.403246", "name": "manhole_896_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392451.47816477320157, 5866658.403246088884771 ] } }, -{ "type": "Feature", "properties": { "_index": 895, "bedlevel": 923.29998779296875, "branchid": "pipe_49_E135;pipe_49_E136", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_897_generated", "shape": null, "area": 0.64, "streetlevel": 926.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 926.29998779296875, "distance_right": 2.9789659531254724e-07, "index_right": 904, "nodeid": "1392403.929302_5866643.393430", "id": "1392403.929302_5866643.393430", "name": "manhole_897_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392403.92930177366361, 5866643.393430193886161 ] } }, -{ "type": "Feature", "properties": { "_index": 896, "bedlevel": 846.79998779296875, "branchid": "pipe_49_E136;pipe_49_E137", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_898_generated", "shape": null, "area": 0.64, "streetlevel": 849.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 849.79998779296875, "distance_right": 3.7467334045624815e-07, "index_right": 905, "nodeid": "1392356.380439_5866628.383614", "id": "1392356.380439_5866628.383614", "name": "manhole_898_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392356.380438774125651, 5866628.383614298887551 ] } }, -{ "type": "Feature", "properties": { "_index": 897, "bedlevel": 872.20001220703125, "branchid": "pipe_49_E137;pipe_49_E138", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_899_generated", "shape": null, "area": 0.64, "streetlevel": 875.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 875.20001220703125, "distance_right": 4.6278392403377259e-07, "index_right": 906, "nodeid": "1392308.831576_5866613.373798", "id": "1392308.831576_5866613.373798", "name": "manhole_899_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392308.831575774587691, 5866613.373798403888941 ] } }, -{ "type": "Feature", "properties": { "_index": 898, "bedlevel": 872.20001220703125, "branchid": "pipe_49_E138;pipe_49_E139", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_900_generated", "shape": null, "area": 0.64, "streetlevel": 875.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 875.20001220703125, "distance_right": 5.3904050343464332e-07, "index_right": 907, "nodeid": "1392261.282713_5866598.363983", "id": "1392261.282713_5866598.363983", "name": "manhole_900_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392261.282712775049731, 5866598.363982509821653 ] } }, -{ "type": "Feature", "properties": { "_index": 899, "bedlevel": 925.10003662109375, "branchid": "pipe_49_E139;pipe_49_E140", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_901_generated", "shape": null, "area": 0.64, "streetlevel": 928.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 928.10003662109375, "distance_right": 4.461385093761408e-07, "index_right": 908, "nodeid": "1392213.733850_5866583.354167", "id": "1392213.733850_5866583.354167", "name": "manhole_901_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392213.733849775511771, 5866583.354166614823043 ] } }, -{ "type": "Feature", "properties": { "_index": 900, "bedlevel": 925.10003662109375, "branchid": "pipe_49_E140;pipe_49_E141", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_902_generated", "shape": null, "area": 0.64, "streetlevel": 928.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 928.10003662109375, "distance_right": 3.5882065240057058e-07, "index_right": 909, "nodeid": "1392166.184987_5866568.344351", "id": "1392166.184987_5866568.344351", "name": "manhole_902_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392166.184986775973812, 5866568.344350719824433 ] } }, -{ "type": "Feature", "properties": { "_index": 901, "bedlevel": 933.79998779296875, "branchid": "pipe_49_E141;pipe_49_E142", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_903_generated", "shape": null, "area": 0.64, "streetlevel": 936.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 936.79998779296875, "distance_right": 5.0133714651316256e-07, "index_right": 910, "nodeid": "1392119.234378_5866551.590171", "id": "1392119.234378_5866551.590171", "name": "manhole_903_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392119.234377897810191, 5866551.59017149079591 ] } }, -{ "type": "Feature", "properties": { "_index": 902, "bedlevel": 933.79998779296875, "branchid": "pipe_49_E142;pipe_49_E143", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_904_generated", "shape": null, "area": 0.64, "streetlevel": 936.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 936.79998779296875, "distance_right": 3.4515468306535673e-07, "index_right": 911, "nodeid": "1392072.481987_5866534.258036", "id": "1392072.481987_5866534.258036", "name": "manhole_904_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392072.481987217208371, 5866534.25803626794368 ] } }, -{ "type": "Feature", "properties": { "_index": 903, "bedlevel": 926.79998779296875, "branchid": "pipe_49_E143;pipe_49_E144", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_905_generated", "shape": null, "area": 0.64, "streetlevel": 929.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 929.79998779296875, "distance_right": 4.651642196257067e-07, "index_right": 912, "nodeid": "1392025.729597_5866516.925901", "id": "1392025.729597_5866516.925901", "name": "manhole_905_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392025.729596536839381, 5866516.925901044160128 ] } }, -{ "type": "Feature", "properties": { "_index": 904, "bedlevel": 889.29998779296875, "branchid": "pipe_49_E144;pipe_49_E145", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_906_generated", "shape": null, "area": 0.64, "streetlevel": 892.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 892.29998779296875, "distance_right": 2.29953709160046e-07, "index_right": 913, "nodeid": "1391978.977206_5866499.593766", "id": "1391978.977206_5866499.593766", "name": "manhole_906_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391978.977205856470391, 5866499.593765820376575 ] } }, -{ "type": "Feature", "properties": { "_index": 905, "bedlevel": 908.4000244140625, "branchid": "pipe_49_E145;pipe_49_E146", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_907_generated", "shape": null, "area": 0.64, "streetlevel": 911.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 911.4000244140625, "distance_right": 4.3991124339150539e-07, "index_right": 914, "nodeid": "1391932.224815_5866482.261631", "id": "1391932.224815_5866482.261631", "name": "manhole_907_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391932.224815175868571, 5866482.261630596593022 ] } }, -{ "type": "Feature", "properties": { "_index": 906, "bedlevel": 908.4000244140625, "branchid": "pipe_49_E146;pipe_49_E147", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_908_generated", "shape": null, "area": 0.64, "streetlevel": 911.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 911.4000244140625, "distance_right": 6.1988875341513863e-07, "index_right": 915, "nodeid": "1391885.472424_5866464.929495", "id": "1391885.472424_5866464.929495", "name": "manhole_908_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391885.472424495499581, 5866464.92949537280947 ] } }, -{ "type": "Feature", "properties": { "_index": 907, "bedlevel": 930.20001220703125, "branchid": "pipe_49_E147;pipe_49_E148", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_909_generated", "shape": null, "area": 0.64, "streetlevel": 933.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 933.20001220703125, "distance_right": 2.3821214812358952e-07, "index_right": 916, "nodeid": "1391838.720034_5866447.597360", "id": "1391838.720034_5866447.597360", "name": "manhole_909_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391838.720033814897761, 5866447.59736014995724 ] } }, -{ "type": "Feature", "properties": { "_index": 908, "bedlevel": 930.20001220703125, "branchid": "pipe_49_E148;pipe_49_E149", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_910_generated", "shape": null, "area": 0.64, "streetlevel": 933.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 933.20001220703125, "distance_right": 1.5337514315044009e-07, "index_right": 917, "nodeid": "1391791.967643_5866430.265225", "id": "1391791.967643_5866430.265225", "name": "manhole_910_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391791.967643134528771, 5866430.265224926173687 ] } }, -{ "type": "Feature", "properties": { "_index": 909, "bedlevel": 936.4000244140625, "branchid": "pipe_49_E149;pipe_49_E150", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_911_generated", "shape": null, "area": 0.64, "streetlevel": 939.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 939.4000244140625, "distance_right": 5.4309463265053459e-07, "index_right": 918, "nodeid": "1391745.215252_5866412.933090", "id": "1391745.215252_5866412.933090", "name": "manhole_911_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391745.215252453926951, 5866412.933089702390134 ] } }, -{ "type": "Feature", "properties": { "_index": 910, "bedlevel": 936.4000244140625, "branchid": "pipe_49_E150;pipe_49_E151", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_912_generated", "shape": null, "area": 0.64, "streetlevel": 939.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 939.4000244140625, "distance_right": 5.2959964469147424e-07, "index_right": 919, "nodeid": "1391698.462862_5866395.600954", "id": "1391698.462862_5866395.600954", "name": "manhole_912_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391698.462861773557961, 5866395.600954478606582 ] } }, -{ "type": "Feature", "properties": { "_index": 911, "bedlevel": 949.70001220703125, "branchid": "pipe_49_E151;pipe_49_E152", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_913_generated", "shape": null, "area": 0.64, "streetlevel": 952.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 952.70001220703125, "distance_right": 2.7156648052421829e-07, "index_right": 920, "nodeid": "1391651.710471_5866378.268819", "id": "1391651.710471_5866378.268819", "name": "manhole_913_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391651.710471092956141, 5866378.268819254823029 ] } }, -{ "type": "Feature", "properties": { "_index": 912, "bedlevel": 886.4000244140625, "branchid": "pipe_49_E152;pipe_49_E153", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_914_generated", "shape": null, "area": 0.64, "streetlevel": 889.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 889.4000244140625, "distance_right": 4.1371902379653219e-07, "index_right": 921, "nodeid": "1391604.958080_5866360.936684", "id": "1391604.958080_5866360.936684", "name": "manhole_914_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391604.958080412587151, 5866360.936684031039476 ] } }, -{ "type": "Feature", "properties": { "_index": 913, "bedlevel": 845.70001220703125, "branchid": "pipe_49_E153;pipe_49_E154", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_915_generated", "shape": null, "area": 0.64, "streetlevel": 848.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 848.70001220703125, "distance_right": 3.293937330443308e-07, "index_right": 922, "nodeid": "1391558.205690_5866343.604549", "id": "1391558.205690_5866343.604549", "name": "manhole_915_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391558.205689732218161, 5866343.604548808187246 ] } }, -{ "type": "Feature", "properties": { "_index": 914, "bedlevel": 845.70001220703125, "branchid": "pipe_49_E154;pipe_49_E155", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_916_generated", "shape": null, "area": 0.64, "streetlevel": 848.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 848.70001220703125, "distance_right": 4.1857355203971027e-07, "index_right": 923, "nodeid": "1391511.453299_5866326.272414", "id": "1391511.453299_5866326.272414", "name": "manhole_916_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391511.453299051616341, 5866326.272413584403694 ] } }, -{ "type": "Feature", "properties": { "_index": 915, "bedlevel": 843.0, "branchid": "pipe_49_E155;pipe_49_E156", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_917_generated", "shape": null, "area": 0.64, "streetlevel": 846.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 846.0, "distance_right": 5.173421456765862e-07, "index_right": 924, "nodeid": "1391464.700908_5866308.940278", "id": "1391464.700908_5866308.940278", "name": "manhole_917_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391464.700908371247351, 5866308.940278360620141 ] } }, -{ "type": "Feature", "properties": { "_index": 916, "bedlevel": 843.0, "branchid": "pipe_49_E156;pipe_49_E157", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_918_generated", "shape": null, "area": 0.64, "streetlevel": 846.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 846.0, "distance_right": 3.3836509315063795e-07, "index_right": 925, "nodeid": "1391417.948518_5866291.608143", "id": "1391417.948518_5866291.608143", "name": "manhole_918_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391417.948517690645531, 5866291.608143136836588 ] } }, -{ "type": "Feature", "properties": { "_index": 917, "bedlevel": 846.9000244140625, "branchid": "pipe_49_E157;pipe_49_E158", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_919_generated", "shape": null, "area": 0.64, "streetlevel": 849.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 849.9000244140625, "distance_right": 8.7216755512678289e-08, "index_right": 926, "nodeid": "1391371.196127_5866274.276008", "id": "1391371.196127_5866274.276008", "name": "manhole_919_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391371.196127010276541, 5866274.276007913053036 ] } }, -{ "type": "Feature", "properties": { "_index": 918, "bedlevel": 846.9000244140625, "branchid": "pipe_49_E158;pipe_49_E159", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_920_generated", "shape": null, "area": 0.64, "streetlevel": 849.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 849.9000244140625, "distance_right": 4.5390732579378692e-07, "index_right": 927, "nodeid": "1391321.986833_5866269.550852", "id": "1391321.986833_5866269.550852", "name": "manhole_920_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391321.986832652939484, 5866269.550851707346737 ] } }, -{ "type": "Feature", "properties": { "_index": 919, "bedlevel": 892.70001220703125, "branchid": "pipe_49_E159;pipe_49_E160", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_921_generated", "shape": null, "area": 0.64, "streetlevel": 895.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 895.70001220703125, "distance_right": 3.7289003346476757e-07, "index_right": 928, "nodeid": "1391272.147465_5866268.058759", "id": "1391272.147465_5866268.058759", "name": "manhole_921_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391272.147464629728347, 5866268.058758955448866 ] } }, -{ "type": "Feature", "properties": { "_index": 920, "bedlevel": 892.70001220703125, "branchid": "pipe_49_E160;pipe_49_E161", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_922_generated", "shape": null, "area": 0.64, "streetlevel": 895.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 895.70001220703125, "distance_right": 4.43839029083394e-07, "index_right": 929, "nodeid": "1391222.308097_5866266.566666", "id": "1391222.308097_5866266.566666", "name": "manhole_922_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391222.30809660628438, 5866266.566666204482317 ] } }, -{ "type": "Feature", "properties": { "_index": 921, "bedlevel": 929.0, "branchid": "pipe_49_E161;pipe_49_E162", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_923_generated", "shape": null, "area": 0.64, "streetlevel": 932.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 932.0, "distance_right": 6.1558942756283069e-07, "index_right": 930, "nodeid": "1391172.468729_5866265.074573", "id": "1391172.468729_5866265.074573", "name": "manhole_923_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391172.468728582840413, 5866265.074573452584445 ] } }, -{ "type": "Feature", "properties": { "_index": 922, "bedlevel": 929.0, "branchid": "pipe_49_E162;pipe_49_E163", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_924_generated", "shape": null, "area": 0.64, "streetlevel": 932.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 932.0, "distance_right": 5.3218673253055169e-07, "index_right": 931, "nodeid": "1391122.629361_5866263.582481", "id": "1391122.629361_5866263.582481", "name": "manhole_924_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391122.629360559629276, 5866263.582480700686574 ] } }, -{ "type": "Feature", "properties": { "_index": 923, "bedlevel": 912.20001220703125, "branchid": "pipe_49_E163;pipe_49_E164", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_925_generated", "shape": null, "area": 0.64, "streetlevel": 915.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 915.20001220703125, "distance_right": 4.6651731725205036e-07, "index_right": 932, "nodeid": "1391072.789993_5866262.090388", "id": "1391072.789993_5866262.090388", "name": "manhole_925_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391072.789992536185309, 5866262.090387949720025 ] } }, -{ "type": "Feature", "properties": { "_index": 924, "bedlevel": 877.70001220703125, "branchid": "pipe_49_E164;pipe_49_E165", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_926_generated", "shape": null, "area": 0.64, "streetlevel": 880.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 880.70001220703125, "distance_right": 5.2579289086766228e-07, "index_right": 933, "nodeid": "1391022.950625_5866260.598295", "id": "1391022.950625_5866260.598295", "name": "manhole_926_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391022.950624512741342, 5866260.598295197822154 ] } }, -{ "type": "Feature", "properties": { "_index": 925, "bedlevel": 877.70001220703125, "branchid": "pipe_49_E165;pipe_49_E166", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_927_generated", "shape": null, "area": 0.64, "streetlevel": 880.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 880.70001220703125, "distance_right": 6.6238845009442494e-07, "index_right": 934, "nodeid": "1390973.111256_5866259.106202", "id": "1390973.111256_5866259.106202", "name": "manhole_927_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390973.111256489530206, 5866259.106202445924282 ] } }, -{ "type": "Feature", "properties": { "_index": 926, "bedlevel": 886.4000244140625, "branchid": "pipe_49_E166;pipe_49_E167", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_928_generated", "shape": null, "area": 0.64, "streetlevel": 889.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 889.4000244140625, "distance_right": 5.573047437679622e-07, "index_right": 935, "nodeid": "1390923.271888_5866257.614110", "id": "1390923.271888_5866257.614110", "name": "manhole_928_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390923.271888466086239, 5866257.614109694957733 ] } }, -{ "type": "Feature", "properties": { "_index": 927, "bedlevel": 886.4000244140625, "branchid": "pipe_49_E167;pipe_49_E168", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_929_generated", "shape": null, "area": 0.64, "streetlevel": 889.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 889.4000244140625, "distance_right": 4.462420842811324e-07, "index_right": 936, "nodeid": "1390873.432520_5866256.122017", "id": "1390873.432520_5866256.122017", "name": "manhole_929_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390873.432520442642272, 5866256.122016943059862 ] } }, -{ "type": "Feature", "properties": { "_index": 928, "bedlevel": 932.79998779296875, "branchid": "pipe_49_E168;pipe_49_E169", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_930_generated", "shape": null, "area": 0.64, "streetlevel": 935.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 935.79998779296875, "distance_right": 4.6053406929521989e-07, "index_right": 937, "nodeid": "1390823.593152_5866254.629924", "id": "1390823.593152_5866254.629924", "name": "manhole_930_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390823.593152419198304, 5866254.62992419116199 ] } }, -{ "type": "Feature", "properties": { "_index": 929, "bedlevel": 932.79998779296875, "branchid": "pipe_49_E169;pipe_49_E170", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_931_generated", "shape": null, "area": 0.64, "streetlevel": 935.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 935.79998779296875, "distance_right": 5.9237281907764308e-07, "index_right": 938, "nodeid": "1390773.753784_5866253.137831", "id": "1390773.753784_5866253.137831", "name": "manhole_931_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390773.753784395987168, 5866253.137831440195441 ] } }, -{ "type": "Feature", "properties": { "_index": 930, "bedlevel": 954.79998779296875, "branchid": "pipe_49_E170;pipe_49_E171", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_932_generated", "shape": null, "area": 0.64, "streetlevel": 957.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 957.79998779296875, "distance_right": 4.8591928251911668e-07, "index_right": 939, "nodeid": "1390723.914416_5866251.645739", "id": "1390723.914416_5866251.645739", "name": "manhole_932_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390723.914416372543201, 5866251.64573868829757 ] } }, -{ "type": "Feature", "properties": { "_index": 931, "bedlevel": 954.79998779296875, "branchid": "pipe_49_E171;pipe_49_E172", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_933_generated", "shape": null, "area": 0.64, "streetlevel": 957.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 957.79998779296875, "distance_right": 3.5471234679006232e-07, "index_right": 940, "nodeid": "1390674.075048_5866250.153646", "id": "1390674.075048_5866250.153646", "name": "manhole_933_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390674.075048349099234, 5866250.153645936399698 ] } }, -{ "type": "Feature", "properties": { "_index": 932, "bedlevel": 954.0, "branchid": "pipe_49_E172;pipe_49_E173", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_934_generated", "shape": null, "area": 0.64, "streetlevel": 957.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 957.0, "distance_right": 3.7496693866214152e-07, "index_right": 941, "nodeid": "1390624.235680_5866248.661553", "id": "1390624.235680_5866248.661553", "name": "manhole_934_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390624.235680325888097, 5866248.661553185433149 ] } }, -{ "type": "Feature", "properties": { "_index": 933, "bedlevel": 954.0, "branchid": "pipe_49_E173;pipe_49_E174", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_935_generated", "shape": null, "area": 0.64, "streetlevel": 957.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 957.0, "distance_right": 5.2898676455779151e-07, "index_right": 942, "nodeid": "1390574.396312_5866247.169460", "id": "1390574.396312_5866247.169460", "name": "manhole_935_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390574.39631230244413, 5866247.169460433535278 ] } }, -{ "type": "Feature", "properties": { "_index": 934, "bedlevel": 961.5, "branchid": "pipe_49_E174;pipe_49_E175", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_936_generated", "shape": null, "area": 0.64, "streetlevel": 964.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 964.5, "distance_right": 4.2338240759397399e-07, "index_right": 943, "nodeid": "1390524.556944_5866245.677368", "id": "1390524.556944_5866245.677368", "name": "manhole_936_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390524.556944279000163, 5866245.677367681637406 ] } }, -{ "type": "Feature", "properties": { "_index": 935, "bedlevel": 961.5, "branchid": "pipe_49_E175;pipe_49_E176", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_937_generated", "shape": null, "area": 0.64, "streetlevel": 964.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 964.5, "distance_right": 2.6499942694981953e-07, "index_right": 944, "nodeid": "1390474.717576_5866244.185275", "id": "1390474.717576_5866244.185275", "name": "manhole_937_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390474.717576255789027, 5866244.185274930670857 ] } }, -{ "type": "Feature", "properties": { "_index": 936, "bedlevel": 945.5, "branchid": "pipe_49_E176;pipe_49_E177", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_938_generated", "shape": null, "area": 0.64, "streetlevel": 948.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 948.5, "distance_right": 2.9320284469871218e-07, "index_right": 945, "nodeid": "1390424.878208_5866242.693182", "id": "1390424.878208_5866242.693182", "name": "manhole_938_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390424.87820823234506, 5866242.693182178772986 ] } }, -{ "type": "Feature", "properties": { "_index": 937, "bedlevel": 967.10003662109375, "branchid": "pipe_49_E177;pipe_49_E178", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_939_generated", "shape": null, "area": 0.64, "streetlevel": 970.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 970.10003662109375, "distance_right": 4.7493074115861244e-07, "index_right": 946, "nodeid": "1390375.038840_5866241.201089", "id": "1390375.038840_5866241.201089", "name": "manhole_939_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390375.038840208901092, 5866241.201089426875114 ] } }, -{ "type": "Feature", "properties": { "_index": 938, "bedlevel": 967.10003662109375, "branchid": "pipe_49_E178;pipe_49_E179", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_940_generated", "shape": null, "area": 0.64, "streetlevel": 970.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 970.10003662109375, "distance_right": 3.7358023225235111e-07, "index_right": 947, "nodeid": "1390325.199472_5866239.708997", "id": "1390325.199472_5866239.708997", "name": "manhole_940_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390325.199472185689956, 5866239.708996675908566 ] } }, -{ "type": "Feature", "properties": { "_index": 939, "bedlevel": 972.4000244140625, "branchid": "pipe_49_E179;pipe_49_E180", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_941_generated", "shape": null, "area": 0.64, "streetlevel": 975.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 975.4000244140625, "distance_right": 1.7935411616933843e-07, "index_right": 948, "nodeid": "1390275.360104_5866238.216904", "id": "1390275.360104_5866238.216904", "name": "manhole_941_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390275.360104162245989, 5866238.216903924010694 ] } }, -{ "type": "Feature", "properties": { "_index": 940, "bedlevel": 972.4000244140625, "branchid": "pipe_49_E180;pipe_49_E181", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_942_generated", "shape": null, "area": 0.64, "streetlevel": 975.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 975.4000244140625, "distance_right": 2.2195392457113109e-07, "index_right": 949, "nodeid": "1390225.520736_5866236.724811", "id": "1390225.520736_5866236.724811", "name": "manhole_942_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390225.520736138802022, 5866236.724811173044145 ] } }, -{ "type": "Feature", "properties": { "_index": 941, "bedlevel": 1031.5, "branchid": "pipe_49_E181;pipe_49_E182", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_943_generated", "shape": null, "area": 0.64, "streetlevel": 1034.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1034.5, "distance_right": 4.3644965847580387e-07, "index_right": 950, "nodeid": "1390175.681368_5866235.232718", "id": "1390175.681368_5866235.232718", "name": "manhole_943_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390175.681368115358055, 5866235.232718421146274 ] } }, -{ "type": "Feature", "properties": { "_index": 942, "bedlevel": 1031.5, "branchid": "pipe_49_E182;pipe_49_E183", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_944_generated", "shape": null, "area": 0.64, "streetlevel": 1034.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1034.5, "distance_right": 3.4323501485718629e-07, "index_right": 951, "nodeid": "1390125.842000_5866233.740626", "id": "1390125.842000_5866233.740626", "name": "manhole_944_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390125.842000092146918, 5866233.740625669248402 ] } }, -{ "type": "Feature", "properties": { "_index": 943, "bedlevel": 1050.9000244140625, "branchid": "pipe_49_E183;pipe_49_E184", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_945_generated", "shape": null, "area": 0.64, "streetlevel": 1053.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1053.9000244140625, "distance_right": 1.0693214671935539e-07, "index_right": 952, "nodeid": "1390076.002632_5866232.248533", "id": "1390076.002632_5866232.248533", "name": "manhole_945_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390076.002632068702951, 5866232.248532918281853 ] } }, -{ "type": "Feature", "properties": { "_index": 944, "bedlevel": 953.9000244140625, "branchid": "pipe_49_E184;pipe_49_E185", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_946_generated", "shape": null, "area": 0.64, "streetlevel": 956.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 956.9000244140625, "distance_right": 1.7271765716066688e-07, "index_right": 953, "nodeid": "1390026.163264_5866230.756440", "id": "1390026.163264_5866230.756440", "name": "manhole_946_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390026.163264045258984, 5866230.756440166383982 ] } }, -{ "type": "Feature", "properties": { "_index": 945, "bedlevel": 985.79998779296875, "branchid": "pipe_49_E185;pipe_49_E186", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_947_generated", "shape": null, "area": 0.64, "streetlevel": 988.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 988.79998779296875, "distance_right": 4.1502837781950249e-07, "index_right": 954, "nodeid": "1389976.323896_5866229.264347", "id": "1389976.323896_5866229.264347", "name": "manhole_947_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389976.323896022047848, 5866229.26434741448611 ] } }, -{ "type": "Feature", "properties": { "_index": 946, "bedlevel": 985.79998779296875, "branchid": "pipe_49_E186;pipe_49_E187", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_948_generated", "shape": null, "area": 0.64, "streetlevel": 988.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 988.79998779296875, "distance_right": 3.3621035174470345e-07, "index_right": 955, "nodeid": "1389926.484528_5866227.772255", "id": "1389926.484528_5866227.772255", "name": "manhole_948_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389926.48452799860388, 5866227.772254663519561 ] } }, -{ "type": "Feature", "properties": { "_index": 947, "bedlevel": 1048.0999755859375, "branchid": "pipe_49_E187;pipe_49_E188", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_949_generated", "shape": null, "area": 0.64, "streetlevel": 1051.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1051.0999755859375, "distance_right": 9.1916218476309546e-08, "index_right": 956, "nodeid": "1389876.645160_5866226.280162", "id": "1389876.645160_5866226.280162", "name": "manhole_949_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389876.645159975159913, 5866226.28016191162169 ] } }, -{ "type": "Feature", "properties": { "_index": 948, "bedlevel": 1048.0999755859375, "branchid": "pipe_49_E188;pipe_49_E189", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_950_generated", "shape": null, "area": 0.64, "streetlevel": 1051.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1051.0999755859375, "distance_right": 1.6721390440459392e-07, "index_right": 957, "nodeid": "1389826.805792_5866224.788069", "id": "1389826.805792_5866224.788069", "name": "manhole_950_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389826.805791951948777, 5866224.788069159723818 ] } }, -{ "type": "Feature", "properties": { "_index": 949, "bedlevel": 1063.9000244140625, "branchid": "pipe_49_E189;pipe_49_E190", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_951_generated", "shape": null, "area": 0.64, "streetlevel": 1066.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1066.9000244140625, "distance_right": 4.1505188836408448e-07, "index_right": 958, "nodeid": "1389776.966424_5866223.295976", "id": "1389776.966424_5866223.295976", "name": "manhole_951_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389776.96642392850481, 5866223.295976408757269 ] } }, -{ "type": "Feature", "properties": { "_index": 950, "bedlevel": 1028.2000732421875, "branchid": "pipe_49_E190;pipe_49_E191", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_952_generated", "shape": null, "area": 0.64, "streetlevel": 1031.2000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1031.2000732421875, "distance_right": 1.7605953720432244e-07, "index_right": 959, "nodeid": "1389727.141183_5866221.468200", "id": "1389727.141183_5866221.468200", "name": "manhole_952_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389727.141182830790058, 5866221.468200048431754 ] } }, -{ "type": "Feature", "properties": { "_index": 951, "bedlevel": 1028.2000732421875, "branchid": "pipe_49_E191;pipe_49_E192", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_953_generated", "shape": null, "area": 0.64, "streetlevel": 1031.2000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1031.2000732421875, "distance_right": 3.6128834460839566e-07, "index_right": 960, "nodeid": "1389677.352676_5866218.767548", "id": "1389677.352676_5866218.767548", "name": "manhole_953_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389677.352675863076001, 5866218.767548334784806 ] } }, -{ "type": "Feature", "properties": { "_index": 952, "bedlevel": 983.60003662109375, "branchid": "pipe_49_E192;pipe_49_E193", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_954_generated", "shape": null, "area": 0.64, "streetlevel": 986.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 986.60003662109375, "distance_right": 3.9313838553029594e-07, "index_right": 961, "nodeid": "1389627.564169_5866216.066897", "id": "1389627.564169_5866216.066897", "name": "manhole_954_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389627.564168895594776, 5866216.066896621137857 ] } }, -{ "type": "Feature", "properties": { "_index": 953, "bedlevel": 983.60003662109375, "branchid": "pipe_49_E193;pipe_49_E194", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_955_generated", "shape": null, "area": 0.64, "streetlevel": 986.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 986.60003662109375, "distance_right": 1.1709228767436902e-07, "index_right": 962, "nodeid": "1389577.775662_5866213.366245", "id": "1389577.775662_5866213.366245", "name": "manhole_955_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389577.775661927880719, 5866213.366244907490909 ] } }, -{ "type": "Feature", "properties": { "_index": 954, "bedlevel": 961.70001220703125, "branchid": "pipe_49_E194;pipe_49_E195", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_956_generated", "shape": null, "area": 0.64, "streetlevel": 964.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 964.70001220703125, "distance_right": 1.9867658609749133e-07, "index_right": 963, "nodeid": "1389527.987155_5866210.665593", "id": "1389527.987155_5866210.665593", "name": "manhole_956_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389527.987154960166663, 5866210.665593194775283 ] } }, -{ "type": "Feature", "properties": { "_index": 955, "bedlevel": 961.70001220703125, "branchid": "pipe_49_E195;pipe_49_E196", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_957_generated", "shape": null, "area": 0.64, "streetlevel": 964.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 964.70001220703125, "distance_right": 4.8155141235013908e-07, "index_right": 964, "nodeid": "1389478.198648_5866207.964941", "id": "1389478.198648_5866207.964941", "name": "manhole_957_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389478.198647992452607, 5866207.964941481128335 ] } }, -{ "type": "Feature", "properties": { "_index": 956, "bedlevel": 993.29998779296875, "branchid": "pipe_49_E196;pipe_49_E197", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_958_generated", "shape": null, "area": 0.64, "streetlevel": 996.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 996.29998779296875, "distance_right": 2.3413503241671798e-07, "index_right": 965, "nodeid": "1389428.410141_5866205.264290", "id": "1389428.410141_5866205.264290", "name": "manhole_958_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389428.41014102473855, 5866205.264289767481387 ] } }, -{ "type": "Feature", "properties": { "_index": 957, "bedlevel": 993.29998779296875, "branchid": "pipe_49_E197;pipe_49_E198", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_959_generated", "shape": null, "area": 0.64, "streetlevel": 996.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 996.29998779296875, "distance_right": 7.856059226332952e-08, "index_right": 966, "nodeid": "1389378.621634_5866202.563638", "id": "1389378.621634_5866202.563638", "name": "manhole_959_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389378.621634057024494, 5866202.563638053834438 ] } }, -{ "type": "Feature", "properties": { "_index": 958, "bedlevel": 1027.4000244140625, "branchid": "pipe_49_E198;pipe_49_E199", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_960_generated", "shape": null, "area": 0.64, "streetlevel": 1030.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1030.4000244140625, "distance_right": 3.514937742276614e-07, "index_right": 967, "nodeid": "1389328.833127_5866199.862986", "id": "1389328.833127_5866199.862986", "name": "manhole_960_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389328.833127089310437, 5866199.86298634018749 ] } }, -{ "type": "Feature", "properties": { "_index": 959, "bedlevel": 1027.4000244140625, "branchid": "pipe_49_E199;pipe_49_E200", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_961_generated", "shape": null, "area": 0.64, "streetlevel": 1030.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1030.4000244140625, "distance_right": 3.9281124173343443e-07, "index_right": 968, "nodeid": "1389279.044620_5866197.162335", "id": "1389279.044620_5866197.162335", "name": "manhole_961_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389279.044620121829212, 5866197.162334626540542 ] } }, -{ "type": "Feature", "properties": { "_index": 960, "bedlevel": 1050.800048828125, "branchid": "pipe_49_E200;pipe_49_E201", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_962_generated", "shape": null, "area": 0.64, "streetlevel": 1053.800048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1053.800048828125, "distance_right": 1.7726043879219753e-07, "index_right": 969, "nodeid": "1389229.256113_5866194.461683", "id": "1389229.256113_5866194.461683", "name": "manhole_962_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389229.256113154115155, 5866194.461682912893593 ] } }, -{ "type": "Feature", "properties": { "_index": 961, "bedlevel": 1050.800048828125, "branchid": "pipe_49_E201;pipe_49_E202", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_963_generated", "shape": null, "area": 0.64, "streetlevel": 1053.800048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1053.800048828125, "distance_right": 2.7295229996532459e-07, "index_right": 970, "nodeid": "1389179.467606_5866191.761031", "id": "1389179.467606_5866191.761031", "name": "manhole_963_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389179.467606186401099, 5866191.761031199246645 ] } }, -{ "type": "Feature", "properties": { "_index": 962, "bedlevel": 1064.5999755859375, "branchid": "pipe_49_E202;pipe_49_E203", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_964_generated", "shape": null, "area": 0.64, "streetlevel": 1067.5999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1067.5999755859375, "distance_right": 5.3219895594374747e-07, "index_right": 971, "nodeid": "1389129.679099_5866189.060379", "id": "1389129.679099_5866189.060379", "name": "manhole_964_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389129.679099218687043, 5866189.060379485599697 ] } }, -{ "type": "Feature", "properties": { "_index": 963, "bedlevel": 1067.7000732421875, "branchid": "pipe_49_E203;pipe_49_E204", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_965_generated", "shape": null, "area": 0.64, "streetlevel": 1070.7000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1070.7000732421875, "distance_right": 3.3920508279400263e-07, "index_right": 972, "nodeid": "1389079.890592_5866186.359728", "id": "1389079.890592_5866186.359728", "name": "manhole_965_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389079.890592250972986, 5866186.359727771952748 ] } }, -{ "type": "Feature", "properties": { "_index": 964, "bedlevel": 1067.7000732421875, "branchid": "pipe_49_E204;pipe_49_E205", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_966_generated", "shape": null, "area": 0.64, "streetlevel": 1070.7000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1070.7000732421875, "distance_right": 2.8936577943892251e-07, "index_right": 973, "nodeid": "1389030.102085_5866183.659076", "id": "1389030.102085_5866183.659076", "name": "manhole_966_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389030.10208528325893, 5866183.6590760583058 ] } }, -{ "type": "Feature", "properties": { "_index": 965, "bedlevel": 1072.0, "branchid": "pipe_49_E205;pipe_49_E206", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_967_generated", "shape": null, "area": 0.64, "streetlevel": 1075.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1075.0, "distance_right": 4.6804125381191257e-07, "index_right": 974, "nodeid": "1388980.313578_5866180.958424", "id": "1388980.313578_5866180.958424", "name": "manhole_967_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388980.313578315777704, 5866180.958424345590174 ] } }, -{ "type": "Feature", "properties": { "_index": 966, "bedlevel": 1072.0, "branchid": "pipe_49_E206;pipe_49_E207", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_968_generated", "shape": null, "area": 0.64, "streetlevel": 1075.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1075.0, "distance_right": 5.0644946756573003e-07, "index_right": 975, "nodeid": "1388930.525071_5866178.257773", "id": "1388930.525071_5866178.257773", "name": "manhole_968_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388930.525071348063648, 5866178.257772631943226 ] } }, -{ "type": "Feature", "properties": { "_index": 967, "bedlevel": 1071.0999755859375, "branchid": "pipe_49_E207;pipe_49_E208", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_969_generated", "shape": null, "area": 0.64, "streetlevel": 1074.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1074.0999755859375, "distance_right": 3.891727817833842e-07, "index_right": 976, "nodeid": "1388880.736564_5866175.557121", "id": "1388880.736564_5866175.557121", "name": "manhole_969_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388880.736564380349591, 5866175.557120918296278 ] } }, -{ "type": "Feature", "properties": { "_index": 968, "bedlevel": 1071.0999755859375, "branchid": "pipe_49_E208;pipe_49_E209", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_970_generated", "shape": null, "area": 0.64, "streetlevel": 1074.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1074.0999755859375, "distance_right": 4.606508242010698e-07, "index_right": 977, "nodeid": "1388830.948057_5866172.856469", "id": "1388830.948057_5866172.856469", "name": "manhole_970_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388830.948057412635535, 5866172.856469204649329 ] } }, -{ "type": "Feature", "properties": { "_index": 969, "bedlevel": 1050.800048828125, "branchid": "pipe_49_E209;pipe_49_E210", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_971_generated", "shape": null, "area": 0.64, "streetlevel": 1053.800048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1053.800048828125, "distance_right": 6.6246701218026935e-07, "index_right": 978, "nodeid": "1388781.159550_5866170.155817", "id": "1388781.159550_5866170.155817", "name": "manhole_971_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388781.159550444921479, 5866170.155817491002381 ] } }, -{ "type": "Feature", "properties": { "_index": 970, "bedlevel": 1050.800048828125, "branchid": "pipe_49_E210;pipe_49_E211", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_972_generated", "shape": null, "area": 0.64, "streetlevel": 1053.800048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1053.800048828125, "distance_right": 5.2665221097907886e-07, "index_right": 979, "nodeid": "1388731.371043_5866167.455166", "id": "1388731.371043_5866167.455166", "name": "manhole_972_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388731.371043477207422, 5866167.455165777355433 ] } }, -{ "type": "Feature", "properties": { "_index": 971, "bedlevel": 1014.0, "branchid": "pipe_49_E211;pipe_49_E212", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_973_generated", "shape": null, "area": 0.64, "streetlevel": 1017.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1017.0, "distance_right": 4.9464501735930622e-07, "index_right": 980, "nodeid": "1388681.582537_5866164.754514", "id": "1388681.582537_5866164.754514", "name": "manhole_973_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388681.582536509493366, 5866164.754514063708484 ] } }, -{ "type": "Feature", "properties": { "_index": 972, "bedlevel": 1014.0, "branchid": "pipe_49_E212;pipe_49_E213", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_974_generated", "shape": null, "area": 0.64, "streetlevel": 1017.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1017.0, "distance_right": 5.7651354540620896e-07, "index_right": 981, "nodeid": "1388631.794030_5866162.053862", "id": "1388631.794030_5866162.053862", "name": "manhole_974_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388631.79402954201214, 5866162.053862350061536 ] } }, -{ "type": "Feature", "properties": { "_index": 973, "bedlevel": 970.20001220703125, "branchid": "pipe_49_E213;pipe_49_E214", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_975_generated", "shape": null, "area": 0.64, "streetlevel": 973.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 973.20001220703125, "distance_right": 5.59529580956339e-07, "index_right": 982, "nodeid": "1388582.005523_5866159.353211", "id": "1388582.005523_5866159.353211", "name": "manhole_975_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388582.005522574298084, 5866159.353210636414587 ] } }, -{ "type": "Feature", "properties": { "_index": 974, "bedlevel": 970.20001220703125, "branchid": "pipe_49_E214;pipe_49_E215", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_976_generated", "shape": null, "area": 0.64, "streetlevel": 973.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 973.20001220703125, "distance_right": 4.0100467111343551e-07, "index_right": 983, "nodeid": "1388532.217016_5866156.652559", "id": "1388532.217016_5866156.652559", "name": "manhole_976_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388532.217015606584027, 5866156.652558922767639 ] } }, -{ "type": "Feature", "properties": { "_index": 975, "bedlevel": 932.20001220703125, "branchid": "pipe_49_E215;pipe_49_E216", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_977_generated", "shape": null, "area": 0.64, "streetlevel": 935.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 935.20001220703125, "distance_right": 4.1751416682829823e-07, "index_right": 984, "nodeid": "1388482.428509_5866153.951907", "id": "1388482.428509_5866153.951907", "name": "manhole_977_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388482.428508638869971, 5866153.951907209120691 ] } }, -{ "type": "Feature", "properties": { "_index": 976, "bedlevel": 932.20001220703125, "branchid": "pipe_49_E216;pipe_49_E217", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_978_generated", "shape": null, "area": 0.64, "streetlevel": 935.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 935.20001220703125, "distance_right": 5.9538979466596884e-07, "index_right": 985, "nodeid": "1388432.640002_5866151.251255", "id": "1388432.640002_5866151.251255", "name": "manhole_978_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388432.640001671155915, 5866151.251255496405065 ] } }, -{ "type": "Feature", "properties": { "_index": 977, "bedlevel": 892.79998779296875, "branchid": "pipe_49_E217;pipe_49_E218", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_979_generated", "shape": null, "area": 0.64, "streetlevel": 895.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 895.79998779296875, "distance_right": 3.6752595508223165e-07, "index_right": 986, "nodeid": "1388382.851495_5866148.550604", "id": "1388382.851495_5866148.550604", "name": "manhole_979_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388382.851494703441858, 5866148.550603782758117 ] } }, -{ "type": "Feature", "properties": { "_index": 978, "bedlevel": 849.60003662109375, "branchid": "pipe_49_E218;pipe_49_E219", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_980_generated", "shape": null, "area": 0.64, "streetlevel": 852.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 852.60003662109375, "distance_right": 2.7287632239397937e-07, "index_right": 987, "nodeid": "1388333.062988_5866145.849952", "id": "1388333.062988_5866145.849952", "name": "manhole_980_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388333.062987735960633, 5866145.849952069111168 ] } }, -{ "type": "Feature", "properties": { "_index": 979, "bedlevel": 849.60003662109375, "branchid": "pipe_49_E219;pipe_49_E220", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_981_generated", "shape": null, "area": 0.64, "streetlevel": 852.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 852.60003662109375, "distance_right": 4.2454476447716075e-07, "index_right": 988, "nodeid": "1388283.274481_5866143.149300", "id": "1388283.274481_5866143.149300", "name": "manhole_981_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388283.274480768246576, 5866143.14930035546422 ] } }, -{ "type": "Feature", "properties": { "_index": 980, "bedlevel": 815.4000244140625, "branchid": "pipe_49_E220;pipe_49_E221", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_982_generated", "shape": null, "area": 0.64, "streetlevel": 818.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 818.4000244140625, "distance_right": 4.1034041195368685e-07, "index_right": 989, "nodeid": "1388233.485974_5866140.448649", "id": "1388233.485974_5866140.448649", "name": "manhole_982_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388233.48597380053252, 5866140.448648641817272 ] } }, -{ "type": "Feature", "properties": { "_index": 981, "bedlevel": 815.4000244140625, "branchid": "pipe_49_E221;pipe_52_E0", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_983_generated", "shape": null, "area": 0.64, "streetlevel": 818.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 818.4000244140625, "distance_right": 1.8190436988416221e-07, "index_right": 990, "nodeid": "1388183.697467_5866137.747997", "id": "1388183.697467_5866137.747997", "name": "manhole_983_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388183.697466832818463, 5866137.747996928170323 ] } }, -{ "type": "Feature", "properties": { "_index": 982, "bedlevel": 791.70001220703125, "branchid": "pipe_50_E0;pipe_50_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_984_generated", "shape": null, "area": 0.64, "streetlevel": 794.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 794.70001220703125, "distance_right": 5.9866458985618213e-08, "index_right": 991, "nodeid": "1387925.204459_5865784.545683", "id": "1387925.204459_5865784.545683", "name": "manhole_984_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387925.20445894007571, 5865784.545682998374104 ] } }, -{ "type": "Feature", "properties": { "_index": 983, "bedlevel": 801.4000244140625, "branchid": "pipe_50_E1;pipe_50_E2", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_985_generated", "shape": null, "area": 0.64, "streetlevel": 804.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 804.4000244140625, "distance_right": 3.4867001082566627e-07, "index_right": 992, "nodeid": "1387937.211691_5865832.252126", "id": "1387937.211691_5865832.252126", "name": "manhole_985_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387937.21169110503979, 5865832.252126332372427 ] } }, -{ "type": "Feature", "properties": { "_index": 984, "bedlevel": 801.4000244140625, "branchid": "pipe_50_E2;pipe_50_E3", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_986_generated", "shape": null, "area": 0.64, "streetlevel": 804.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 804.4000244140625, "distance_right": 3.2490020949153345e-07, "index_right": 993, "nodeid": "1387954.827088_5865878.043408", "id": "1387954.827088_5865878.043408", "name": "manhole_986_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387954.8270876808092, 5865878.043407939374447 ] } }, -{ "type": "Feature", "properties": { "_index": 985, "bedlevel": 801.4000244140625, "branchid": "pipe_50_E3;pipe_50_E4", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_987_generated", "shape": null, "area": 0.64, "streetlevel": 804.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 804.4000244140625, "distance_right": 3.9004074068770563e-07, "index_right": 994, "nodeid": "1387967.620662_5865925.436967", "id": "1387967.620662_5865925.436967", "name": "manhole_987_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387967.620662312954664, 5865925.436966767534614 ] } }, -{ "type": "Feature", "properties": { "_index": 986, "bedlevel": 775.20001220703125, "branchid": "pipe_50_E4;pipe_50_E5", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_988_generated", "shape": null, "area": 0.64, "streetlevel": 778.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 778.20001220703125, "distance_right": 3.6606967785989592e-07, "index_right": 995, "nodeid": "1387969.561903_5865974.386314", "id": "1387969.561903_5865974.386314", "name": "manhole_988_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387969.561903131194413, 5865974.386314341798425 ] } }, -{ "type": "Feature", "properties": { "_index": 987, "bedlevel": 775.20001220703125, "branchid": "pipe_50_E5;pipe_50_E6", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_989_generated", "shape": null, "area": 0.64, "streetlevel": 778.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 778.20001220703125, "distance_right": 2.676742433793445e-07, "index_right": 996, "nodeid": "1387968.982558_5866023.571072", "id": "1387968.982558_5866023.571072", "name": "manhole_989_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387968.98255812516436, 5866023.571071763522923 ] } }, -{ "type": "Feature", "properties": { "_index": 988, "bedlevel": 775.20001220703125, "branchid": "pipe_50_E6;pipe_50_E7", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_990_generated", "shape": null, "area": 0.64, "streetlevel": 778.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 778.20001220703125, "distance_right": 4.3598829608959754e-07, "index_right": 997, "nodeid": "1387969.225197_5866072.657253", "id": "1387969.225197_5866072.657253", "name": "manhole_990_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387969.225197304505855, 5866072.657253311946988 ] } }, -{ "type": "Feature", "properties": { "_index": 989, "bedlevel": 783.29998779296875, "branchid": "pipe_50_E7;pipe_50_E8", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_991_generated", "shape": null, "area": 0.64, "streetlevel": 786.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 786.29998779296875, "distance_right": 4.7751884879743965e-07, "index_right": 998, "nodeid": "1387988.247400_5866112.298415", "id": "1387988.247400_5866112.298415", "name": "manhole_991_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387988.247399942483753, 5866112.298415473662317 ] } }, -{ "type": "Feature", "properties": { "_index": 990, "bedlevel": 783.29998779296875, "branchid": "pipe_50_E8;pipe_51_E0;pipe_52_E2", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_992_generated", "shape": null, "area": 0.64, "streetlevel": 786.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 786.29998779296875, "distance_right": 3.4258060355880119e-07, "index_right": 999, "nodeid": "1388034.037428_5866130.255608", "id": "1388034.037428_5866130.255608", "name": "manhole_992_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388034.037428337847814, 5866130.255607943050563 ] } }, -{ "type": "Feature", "properties": { "_index": 991, "bedlevel": 783.29998779296875, "branchid": "pipe_51_E0;pipe_51_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_993_generated", "shape": null, "area": 0.64, "streetlevel": 786.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 786.29998779296875, "distance_right": 6.4243645308526241e-07, "index_right": 1000, "nodeid": "1387988.210685_5866144.678138", "id": "1387988.210685_5866144.678138", "name": "manhole_993_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387988.210684564430267, 5866144.678138472139835 ] } }, -{ "type": "Feature", "properties": { "_index": 992, "bedlevel": 800.9000244140625, "branchid": "pipe_51_E1;pipe_51_E2", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_994_generated", "shape": null, "area": 0.64, "streetlevel": 803.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 803.9000244140625, "distance_right": 1.3903011605945694e-07, "index_right": 1001, "nodeid": "1387944.406121_5866164.065103", "id": "1387944.406121_5866164.065103", "name": "manhole_994_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387944.406121137319133, 5866164.065103021450341 ] } }, -{ "type": "Feature", "properties": { "_index": 993, "bedlevel": 800.9000244140625, "branchid": "pipe_51_E2;pipe_51_E3", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_995_generated", "shape": null, "area": 0.64, "streetlevel": 803.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 803.9000244140625, "distance_right": 1.9915718645449805e-07, "index_right": 1002, "nodeid": "1387898.376188_5866173.560076", "id": "1387898.376188_5866173.560076", "name": "manhole_995_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387898.376188111724332, 5866173.560075835324824 ] } }, -{ "type": "Feature", "properties": { "_index": 994, "bedlevel": 824.70001220703125, "branchid": "pipe_51_E3;pipe_51_E4", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_996_generated", "shape": null, "area": 0.64, "streetlevel": 827.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 827.70001220703125, "distance_right": 5.0607040580195112e-07, "index_right": 1003, "nodeid": "1387861.922561_5866145.113870", "id": "1387861.922561_5866145.113870", "name": "manhole_996_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387861.922560503939167, 5866145.113870099186897 ] } }, -{ "type": "Feature", "properties": { "_index": 995, "bedlevel": 824.70001220703125, "branchid": "pipe_51_E4;pipe_51_E5", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_997_generated", "shape": null, "area": 0.64, "streetlevel": 827.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 827.70001220703125, "distance_right": 4.3784946248219545e-07, "index_right": 1004, "nodeid": "1387862.597009_5866099.287654", "id": "1387862.597009_5866099.287654", "name": "manhole_997_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387862.597008766839281, 5866099.287653629668057 ] } }, -{ "type": "Feature", "properties": { "_index": 996, "bedlevel": 813.70001220703125, "branchid": "pipe_51_E5;pipe_51_E6", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_998_generated", "shape": null, "area": 0.64, "streetlevel": 816.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 816.70001220703125, "distance_right": 4.2940434915154824e-07, "index_right": 1005, "nodeid": "1387894.296242_5866064.312252", "id": "1387894.296242_5866064.312252", "name": "manhole_998_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387894.296242429409176, 5866064.31225199252367 ] } }, -{ "type": "Feature", "properties": { "_index": 997, "bedlevel": 813.70001220703125, "branchid": "pipe_51_E6;pipe_51_E7", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_999_generated", "shape": null, "area": 0.64, "streetlevel": 816.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 816.70001220703125, "distance_right": 5.291142332498509e-07, "index_right": 1006, "nodeid": "1387918.333023_5866023.860150", "id": "1387918.333023_5866023.860150", "name": "manhole_999_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387918.333023339277133, 5866023.860149594023824 ] } }, -{ "type": "Feature", "properties": { "_index": 998, "bedlevel": 813.70001220703125, "branchid": "pipe_51_E7;pipe_51_E8", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_1000_generated", "shape": null, "area": 0.64, "streetlevel": 816.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 816.70001220703125, "distance_right": 4.1160348816863167e-07, "index_right": 1007, "nodeid": "1387925.576027_5865976.462518", "id": "1387925.576027_5865976.462518", "name": "manhole_1000_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387925.576027213362977, 5865976.462517648003995 ] } }, -{ "type": "Feature", "properties": { "_index": 999, "bedlevel": 801.4000244140625, "branchid": "pipe_51_E8;pipe_51_E9", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_1001_generated", "shape": null, "area": 0.64, "streetlevel": 804.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 804.4000244140625, "distance_right": 2.6634696055791994e-07, "index_right": 1008, "nodeid": "1387926.166852_5865928.505293", "id": "1387926.166852_5865928.505293", "name": "manhole_1001_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387926.166851800866425, 5865928.505292822606862 ] } }, -{ "type": "Feature", "properties": { "_index": 1000, "bedlevel": 801.4000244140625, "branchid": "pipe_51_E9;pipe_51_E10", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_1002_generated", "shape": null, "area": 0.64, "streetlevel": 804.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 804.4000244140625, "distance_right": 2.9363738265143579e-07, "index_right": 1009, "nodeid": "1387922.175475_5865880.628694", "id": "1387922.175475_5865880.628694", "name": "manhole_1002_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387922.175474973395467, 5865880.628693707287312 ] } }, -{ "type": "Feature", "properties": { "_index": 1001, "bedlevel": 801.4000244140625, "branchid": "pipe_51_E10;pipe_51_E11", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_1003_generated", "shape": null, "area": 0.64, "streetlevel": 804.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 804.4000244140625, "distance_right": 4.3245670675986009e-07, "index_right": 1010, "nodeid": "1387918.184098_5865832.752095", "id": "1387918.184098_5865832.752095", "name": "manhole_1003_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387918.184098146157339, 5865832.752094592899084 ] } }, -{ "type": "Feature", "properties": { "_index": 1002, "bedlevel": 791.70001220703125, "branchid": "pipe_51_E11;pipe_51_E12", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_1004_generated", "shape": null, "area": 0.64, "streetlevel": 794.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 794.70001220703125, "distance_right": 4.0146728020930125e-07, "index_right": 1011, "nodeid": "1387914.316890_5865784.868878", "id": "1387914.316890_5865784.868878", "name": "manhole_1004_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387914.316889721900225, 5865784.868878290057182 ] } }, -{ "type": "Feature", "properties": { "_index": 1004, "bedlevel": 800.9000244140625, "branchid": "pipe_52_E0;pipe_52_E1", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_1005_generated", "shape": null, "area": 0.64, "streetlevel": 803.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 803.9000244140625, "distance_right": 3.4123100246825885e-07, "index_right": 1012, "nodeid": "1388133.810787_5866135.250534", "id": "1388133.810787_5866135.250534", "name": "manhole_1005_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388133.810787334572524, 5866135.250533932819963 ] } }, -{ "type": "Feature", "properties": { "_index": 1005, "bedlevel": 800.9000244140625, "branchid": "pipe_52_E1;pipe_52_E2", "branchtype": "pipe", "diameter": 0.5, "width": null, "manholeid": "manhole_1006_generated", "shape": null, "area": 0.64, "streetlevel": 803.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 803.9000244140625, "distance_right": 1.7505891844349512e-07, "index_right": 1013, "nodeid": "1388083.924108_5866132.753071", "id": "1388083.924108_5866132.753071", "name": "manhole_1006_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388083.924107836093754, 5866132.753070938400924 ] } } +{ "type": "Feature", "properties": { "_index": 6, "bedlevel": 912.9000244140625, "branchid": "pipe_6_E0;pipe_7_E0;pipe_8_E0", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_0_generated", "shape": null, "area": 0.64, "streetlevel": 915.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 915.9000244140625, "distance_right": 2.8955455770766528e-07, "index_right": 7, "nodeid": "1389266.515512_5860111.688303", "id": "1389266.515512_5860111.688303", "name": "manhole_0_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389266.515512115787715, 5860111.688302734866738 ] } }, +{ "type": "Feature", "properties": { "_index": 6, "bedlevel": 912.9000244140625, "branchid": "pipe_6_E0;pipe_6_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_1_generated", "shape": null, "area": 0.64, "streetlevel": 915.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 915.9000244140625, "distance_right": 4.9863431599547954e-07, "index_right": 8, "nodeid": "1389238.298387_5860147.714495", "id": "1389238.298387_5860147.714495", "name": "manhole_1_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389238.298387300921604, 5860147.714495398104191 ] } }, +{ "type": "Feature", "properties": { "_index": 7, "bedlevel": 930.5, "branchid": "pipe_6_E1;pipe_6_E2", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_2_generated", "shape": null, "area": 0.64, "streetlevel": 933.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 933.5, "distance_right": 5.7008358445401274e-07, "index_right": 9, "nodeid": "1389210.947847_5860184.343885", "id": "1389210.947847_5860184.343885", "name": "manhole_2_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389210.947846550960094, 5860184.343885350972414 ] } }, +{ "type": "Feature", "properties": { "_index": 8, "bedlevel": 930.5, "branchid": "pipe_6_E2;pipe_6_E3", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_3_generated", "shape": null, "area": 0.64, "streetlevel": 933.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 933.5, "distance_right": 4.6075272516314234e-07, "index_right": 10, "nodeid": "1389186.961923_5860223.315261", "id": "1389186.961923_5860223.315261", "name": "manhole_3_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389186.961922727525234, 5860223.315261371433735 ] } }, +{ "type": "Feature", "properties": { "_index": 9, "bedlevel": 932.5, "branchid": "pipe_6_E3;pipe_6_E4", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_4_generated", "shape": null, "area": 0.64, "streetlevel": 935.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 935.5, "distance_right": 4.4283537640359513e-07, "index_right": 11, "nodeid": "1389162.755599_5860262.142883", "id": "1389162.755599_5860262.142883", "name": "manhole_4_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389162.755598766496405, 5860262.142883376218379 ] } }, +{ "type": "Feature", "properties": { "_index": 10, "bedlevel": 932.5, "branchid": "pipe_6_E4;pipe_6_E5", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_5_generated", "shape": null, "area": 0.64, "streetlevel": 935.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 935.5, "distance_right": 5.1403775599100041e-07, "index_right": 12, "nodeid": "1389136.759308_5860299.803015", "id": "1389136.759308_5860299.803015", "name": "manhole_5_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389136.759307563304901, 5860299.80301527120173 ] } }, +{ "type": "Feature", "properties": { "_index": 11, "bedlevel": 933.5, "branchid": "pipe_6_E5;pipe_6_E6", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_6_generated", "shape": null, "area": 0.64, "streetlevel": 936.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 936.5, "distance_right": 4.2800833621769655e-07, "index_right": 13, "nodeid": "1389109.730123_5860336.652257", "id": "1389109.730123_5860336.652257", "name": "manhole_6_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389109.7301227634307, 5860336.652257356792688 ] } }, +{ "type": "Feature", "properties": { "_index": 12, "bedlevel": 938.10003662109375, "branchid": "pipe_6_E6;pipe_6_E7", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_7_generated", "shape": null, "area": 0.64, "streetlevel": 941.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 941.10003662109375, "distance_right": 2.8647556573889729e-07, "index_right": 14, "nodeid": "1389073.184788_5860363.522737", "id": "1389073.184788_5860363.522737", "name": "manhole_7_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389073.18478828552179, 5860363.522737024351954 ] } }, +{ "type": "Feature", "properties": { "_index": 13, "bedlevel": 938.10003662109375, "branchid": "pipe_6_E7;pipe_6_E8", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_8_generated", "shape": null, "area": 0.64, "streetlevel": 941.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 941.10003662109375, "distance_right": 3.4023879020567642e-07, "index_right": 15, "nodeid": "1389032.546542_5860384.329287", "id": "1389032.546542_5860384.329287", "name": "manhole_8_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389032.546542100608349, 5860384.329287325032055 ] } }, +{ "type": "Feature", "properties": { "_index": 14, "bedlevel": 938.10003662109375, "branchid": "pipe_6_E8;pipe_6_E9", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_9_generated", "shape": null, "area": 0.64, "streetlevel": 941.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 941.10003662109375, "distance_right": 2.9931735352129969e-07, "index_right": 16, "nodeid": "1388989.578410_5860400.071979", "id": "1388989.578410_5860400.071979", "name": "manhole_9_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388989.578410296700895, 5860400.071978960186243 ] } }, +{ "type": "Feature", "properties": { "_index": 15, "bedlevel": 948.29998779296875, "branchid": "pipe_6_E9;pipe_7_E10;pipe_34_E0", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_10_generated", "shape": null, "area": 0.64, "streetlevel": 951.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 951.29998779296875, "distance_right": 3.4647202562053268e-07, "index_right": 17, "nodeid": "1388946.301101_5860414.883978", "id": "1388946.301101_5860414.883978", "name": "manhole_10_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388946.301100668497384, 5860414.883977899327874 ] } }, +{ "type": "Feature", "properties": { "_index": 16, "bedlevel": 912.9000244140625, "branchid": "pipe_7_E0;pipe_7_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_11_generated", "shape": null, "area": 0.64, "streetlevel": 915.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 915.9000244140625, "distance_right": 2.4635198559591233e-07, "index_right": 18, "nodeid": "1389221.905704_5860123.325637", "id": "1389221.905704_5860123.325637", "name": "manhole_11_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389221.905703959986567, 5860123.3256367566064 ] } }, +{ "type": "Feature", "properties": { "_index": 17, "bedlevel": 912.9000244140625, "branchid": "pipe_7_E1;pipe_7_E2", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_12_generated", "shape": null, "area": 0.64, "streetlevel": 915.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 915.9000244140625, "distance_right": 2.956036043959947e-07, "index_right": 19, "nodeid": "1389177.295896_5860134.962971", "id": "1389177.295896_5860134.962971", "name": "manhole_12_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389177.295895804418251, 5860134.962970778346062 ] } }, +{ "type": "Feature", "properties": { "_index": 18, "bedlevel": 916.60003662109375, "branchid": "pipe_7_E2;pipe_7_E3", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_13_generated", "shape": null, "area": 0.64, "streetlevel": 919.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 919.60003662109375, "distance_right": 4.043941204997758e-07, "index_right": 20, "nodeid": "1389132.686088_5860146.600305", "id": "1389132.686088_5860146.600305", "name": "manhole_13_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389132.686087648617104, 5860146.600304800085723 ] } }, +{ "type": "Feature", "properties": { "_index": 19, "bedlevel": 916.60003662109375, "branchid": "pipe_7_E3;pipe_7_E4", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_14_generated", "shape": null, "area": 0.64, "streetlevel": 919.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 919.60003662109375, "distance_right": 5.2423720860293592e-07, "index_right": 21, "nodeid": "1389088.076279_5860158.237639", "id": "1389088.076279_5860158.237639", "name": "manhole_14_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389088.076279493048787, 5860158.237638821825385 ] } }, +{ "type": "Feature", "properties": { "_index": 20, "bedlevel": 935.10003662109375, "branchid": "pipe_7_E4;pipe_7_E5", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_15_generated", "shape": null, "area": 0.64, "streetlevel": 938.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 938.10003662109375, "distance_right": 4.9176499718456295e-07, "index_right": 22, "nodeid": "1389044.226174_5860172.143309", "id": "1389044.226174_5860172.143309", "name": "manhole_15_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389044.226173994829878, 5860172.143308508209884 ] } }, +{ "type": "Feature", "properties": { "_index": 21, "bedlevel": 935.10003662109375, "branchid": "pipe_7_E5;pipe_7_E6", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_16_generated", "shape": null, "area": 0.64, "streetlevel": 938.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 938.10003662109375, "distance_right": 6.210052013844783e-07, "index_right": 23, "nodeid": "1389012.527182_5860198.239756", "id": "1389012.527182_5860198.239756", "name": "manhole_16_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389012.527182487538084, 5860198.239755615592003 ] } }, +{ "type": "Feature", "properties": { "_index": 22, "bedlevel": 935.10003662109375, "branchid": "pipe_7_E6;pipe_7_E7", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_17_generated", "shape": null, "area": 0.64, "streetlevel": 938.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 938.10003662109375, "distance_right": 4.0494336342938905e-07, "index_right": 24, "nodeid": "1388995.773123_5860240.481283", "id": "1388995.773123_5860240.481283", "name": "manhole_17_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388995.773122631013393, 5860240.481283166445792 ] } }, +{ "type": "Feature", "properties": { "_index": 23, "bedlevel": 942.0, "branchid": "pipe_7_E7;pipe_7_E8", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_18_generated", "shape": null, "area": 0.64, "streetlevel": 945.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 945.0, "distance_right": 3.6384956544063991e-07, "index_right": 25, "nodeid": "1388973.630034_5860280.918224", "id": "1388973.630034_5860280.918224", "name": "manhole_18_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388973.630034049740061, 5860280.918223639950156 ] } }, +{ "type": "Feature", "properties": { "_index": 24, "bedlevel": 948.29998779296875, "branchid": "pipe_7_E8;pipe_7_E9", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_19_generated", "shape": null, "area": 0.64, "streetlevel": 951.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 951.29998779296875, "distance_right": 1.818250807924088e-07, "index_right": 26, "nodeid": "1388961.171158_5860324.081193", "id": "1388961.171158_5860324.081193", "name": "manhole_19_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388961.171157888136804, 5860324.081192856654525 ] } }, +{ "type": "Feature", "properties": { "_index": 25, "bedlevel": 948.29998779296875, "branchid": "pipe_7_E9;pipe_7_E10", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_20_generated", "shape": null, "area": 0.64, "streetlevel": 951.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 951.29998779296875, "distance_right": 1.7347679874173417e-07, "index_right": 27, "nodeid": "1388955.410555_5860369.690169", "id": "1388955.410555_5860369.690169", "name": "manhole_20_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388955.410555170848966, 5860369.690168970264494 ] } }, +{ "type": "Feature", "properties": { "_index": 27, "bedlevel": 911.5, "branchid": "pipe_8_E0;pipe_8_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_21_generated", "shape": null, "area": 0.64, "streetlevel": 914.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 914.5, "distance_right": 1.6748600779980834e-07, "index_right": 28, "nodeid": "1389306.500000_5860083.476415", "id": "1389306.500000_5860083.476415", "name": "manhole_21_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389306.50000010849908, 5860083.476415127515793 ] } }, +{ "type": "Feature", "properties": { "_index": 28, "bedlevel": 911.5, "branchid": "pipe_8_E1;pipe_8_E2", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_22_generated", "shape": null, "area": 0.64, "streetlevel": 914.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 914.5, "distance_right": 5.0701945338922807e-07, "index_right": 29, "nodeid": "1389355.420758_5860074.630405", "id": "1389355.420758_5860074.630405", "name": "manhole_22_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389355.420758404070511, 5860074.630405306816101 ] } }, +{ "type": "Feature", "properties": { "_index": 29, "bedlevel": 926.9000244140625, "branchid": "pipe_8_E2;pipe_8_E3", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_23_generated", "shape": null, "area": 0.64, "streetlevel": 929.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 929.9000244140625, "distance_right": 2.1831036005702163e-07, "index_right": 30, "nodeid": "1389389.090761_5860042.444931", "id": "1389389.090761_5860042.444931", "name": "manhole_23_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389389.090761042200029, 5860042.4449307853356 ] } }, +{ "type": "Feature", "properties": { "_index": 30, "bedlevel": 952.0, "branchid": "pipe_8_E3;pipe_8_E4", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_24_generated", "shape": null, "area": 0.64, "streetlevel": 955.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 955.0, "distance_right": 4.281663745589639e-07, "index_right": 31, "nodeid": "1389404.036260_5859994.775434", "id": "1389404.036260_5859994.775434", "name": "manhole_24_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389404.036260401364416, 5859994.775433851405978 ] } }, +{ "type": "Feature", "properties": { "_index": 31, "bedlevel": 952.0, "branchid": "pipe_8_E4;pipe_8_E5", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_25_generated", "shape": null, "area": 0.64, "streetlevel": 955.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 955.0, "distance_right": 6.595190912537427e-07, "index_right": 32, "nodeid": "1389418.744130_5859947.032029", "id": "1389418.744130_5859947.032029", "name": "manhole_25_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389418.744130451697856, 5859947.032028519548476 ] } }, +{ "type": "Feature", "properties": { "_index": 32, "bedlevel": 952.0, "branchid": "pipe_8_E5;pipe_8_E6", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_26_generated", "shape": null, "area": 0.64, "streetlevel": 955.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 955.0, "distance_right": 3.6224026195323218e-07, "index_right": 33, "nodeid": "1389423.265343_5859897.853970", "id": "1389423.265343_5859897.853970", "name": "manhole_26_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389423.265342897269875, 5859897.853969652205706 ] } }, +{ "type": "Feature", "properties": { "_index": 33, "bedlevel": 972.29998779296875, "branchid": "pipe_8_E6;pipe_8_E7", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_27_generated", "shape": null, "area": 0.64, "streetlevel": 975.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 975.29998779296875, "distance_right": 5.241390138956655e-07, "index_right": 34, "nodeid": "1389395.831074_5859856.743155", "id": "1389395.831074_5859856.743155", "name": "manhole_27_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389395.831073811277747, 5859856.743154510855675 ] } }, +{ "type": "Feature", "properties": { "_index": 34, "bedlevel": 960.0, "branchid": "pipe_8_E7;pipe_8_E8", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_28_generated", "shape": null, "area": 0.64, "streetlevel": 963.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 963.0, "distance_right": 2.4446108841163454e-07, "index_right": 35, "nodeid": "1389350.827043_5859839.640479", "id": "1389350.827043_5859839.640479", "name": "manhole_28_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389350.827042841585353, 5859839.640478814020753 ] } }, +{ "type": "Feature", "properties": { "_index": 35, "bedlevel": 960.0, "branchid": "pipe_8_E8;pipe_8_E9", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_29_generated", "shape": null, "area": 0.64, "streetlevel": 963.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 963.0, "distance_right": 3.9835383960605792e-07, "index_right": 36, "nodeid": "1389303.795789_5859855.887689", "id": "1389303.795789_5859855.887689", "name": "manhole_29_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389303.795788601972163, 5859855.887689013034105 ] } }, +{ "type": "Feature", "properties": { "_index": 36, "bedlevel": 942.4000244140625, "branchid": "pipe_8_E9;pipe_8_E10", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_30_generated", "shape": null, "area": 0.64, "streetlevel": 945.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 945.4000244140625, "distance_right": 3.2789110600907463e-07, "index_right": 37, "nodeid": "1389256.284587_5859863.631581", "id": "1389256.284587_5859863.631581", "name": "manhole_30_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389256.284586790716276, 5859863.631580747663975 ] } }, +{ "type": "Feature", "properties": { "_index": 37, "bedlevel": 942.4000244140625, "branchid": "pipe_8_E10;pipe_8_E11", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_31_generated", "shape": null, "area": 0.64, "streetlevel": 945.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 945.4000244140625, "distance_right": 5.2000591108194085e-07, "index_right": 38, "nodeid": "1389227.308454_5859823.781623", "id": "1389227.308454_5859823.781623", "name": "manhole_31_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389227.308454349869862, 5859823.781623384915292 ] } }, +{ "type": "Feature", "properties": { "_index": 38, "bedlevel": 942.4000244140625, "branchid": "pipe_8_E11;pipe_8_E12", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_32_generated", "shape": null, "area": 0.64, "streetlevel": 945.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 945.4000244140625, "distance_right": 4.4402213892266013e-07, "index_right": 39, "nodeid": "1389202.745489_5859780.279728", "id": "1389202.745489_5859780.279728", "name": "manhole_32_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389202.745489193825051, 5859780.279727600514889 ] } }, +{ "type": "Feature", "properties": { "_index": 39, "bedlevel": 956.10003662109375, "branchid": "pipe_8_E12;pipe_8_E13", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_33_generated", "shape": null, "area": 0.64, "streetlevel": 959.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 959.10003662109375, "distance_right": 1.863954361493274e-07, "index_right": 40, "nodeid": "1389178.182524_5859736.777832", "id": "1389178.182524_5859736.777832", "name": "manhole_33_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389178.18252403778024, 5859736.777831817045808 ] } }, +{ "type": "Feature", "properties": { "_index": 40, "bedlevel": 941.79998779296875, "branchid": "pipe_8_E13;pipe_8_E14", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_34_generated", "shape": null, "area": 0.64, "streetlevel": 944.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 944.79998779296875, "distance_right": 4.7830062000180287e-07, "index_right": 41, "nodeid": "1389155.231297_5859692.450143", "id": "1389155.231297_5859692.450143", "name": "manhole_34_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389155.231297271326184, 5859692.450142606161535 ] } }, +{ "type": "Feature", "properties": { "_index": 41, "bedlevel": 941.79998779296875, "branchid": "pipe_8_E14;pipe_8_E15", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_35_generated", "shape": null, "area": 0.64, "streetlevel": 944.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 944.79998779296875, "distance_right": 4.9671720854496808e-07, "index_right": 42, "nodeid": "1389141.413413_5859644.883845", "id": "1389141.413413_5859644.883845", "name": "manhole_35_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389141.413412723457441, 5859644.883844587020576 ] } }, +{ "type": "Feature", "properties": { "_index": 42, "bedlevel": 949.4000244140625, "branchid": "pipe_8_E15;pipe_8_E16", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_36_generated", "shape": null, "area": 0.64, "streetlevel": 952.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 952.4000244140625, "distance_right": 2.2082179185505829e-07, "index_right": 43, "nodeid": "1389151.802280_5859598.618041", "id": "1389151.802280_5859598.618041", "name": "manhole_36_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389151.802280035568401, 5859598.61804121825844 ] } }, +{ "type": "Feature", "properties": { "_index": 43, "bedlevel": 957.70001220703125, "branchid": "pipe_8_E16;pipe_8_E17", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_37_generated", "shape": null, "area": 0.64, "streetlevel": 960.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 960.70001220703125, "distance_right": 3.7225134857209445e-07, "index_right": 44, "nodeid": "1389191.073855_5859569.046822", "id": "1389191.073855_5859569.046822", "name": "manhole_37_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389191.073854762827978, 5859569.046822287142277 ] } }, +{ "type": "Feature", "properties": { "_index": 44, "bedlevel": 957.70001220703125, "branchid": "pipe_8_E17;pipe_8_E18", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_38_generated", "shape": null, "area": 0.64, "streetlevel": 960.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 960.70001220703125, "distance_right": 4.2091375934231921e-07, "index_right": 45, "nodeid": "1389239.915166_5859563.955490", "id": "1389239.915166_5859563.955490", "name": "manhole_38_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389239.915165816899389, 5859563.955490378662944 ] } }, +{ "type": "Feature", "properties": { "_index": 45, "bedlevel": 966.60003662109375, "branchid": "pipe_8_E18;pipe_8_E19", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_39_generated", "shape": null, "area": 0.64, "streetlevel": 969.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 969.60003662109375, "distance_right": 4.8978984916104921e-07, "index_right": 46, "nodeid": "1389289.757686_5859566.285022", "id": "1389289.757686_5859566.285022", "name": "manhole_39_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389289.757686472963542, 5859566.285022127442062 ] } }, +{ "type": "Feature", "properties": { "_index": 46, "bedlevel": 966.60003662109375, "branchid": "pipe_8_E19;pipe_8_E20", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_40_generated", "shape": null, "area": 0.64, "streetlevel": 969.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 969.60003662109375, "distance_right": 4.5561762419406098e-07, "index_right": 47, "nodeid": "1389339.615828_5859566.079234", "id": "1389339.615828_5859566.079234", "name": "manhole_40_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389339.615828452631831, 5859566.079234052449465 ] } }, +{ "type": "Feature", "properties": { "_index": 47, "bedlevel": 973.29998779296875, "branchid": "pipe_8_E20;pipe_8_E21", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_41_generated", "shape": null, "area": 0.64, "streetlevel": 976.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 976.29998779296875, "distance_right": 3.0780959591952437e-07, "index_right": 48, "nodeid": "1389387.354308_5859551.676989", "id": "1389387.354308_5859551.676989", "name": "manhole_41_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389387.354307833593339, 5859551.676988741382957 ] } }, +{ "type": "Feature", "properties": { "_index": 48, "bedlevel": 973.29998779296875, "branchid": "pipe_8_E21;pipe_8_E22", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_42_generated", "shape": null, "area": 0.64, "streetlevel": 976.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 976.29998779296875, "distance_right": 2.2809906125236904e-07, "index_right": 49, "nodeid": "1389428.692969_5859524.248876", "id": "1389428.692969_5859524.248876", "name": "manhole_42_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389428.692968821851537, 5859524.248876142315567 ] } }, +{ "type": "Feature", "properties": { "_index": 49, "bedlevel": 963.79998779296875, "branchid": "pipe_8_E22;pipe_8_E23", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_43_generated", "shape": null, "area": 0.64, "streetlevel": 966.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 966.79998779296875, "distance_right": 4.7646645185690715e-07, "index_right": 50, "nodeid": "1389461.138922_5859486.477509", "id": "1389461.138922_5859486.477509", "name": "manhole_43_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389461.138921525795013, 5859486.477508954703808 ] } }, +{ "type": "Feature", "properties": { "_index": 50, "bedlevel": 963.79998779296875, "branchid": "pipe_8_E23;pipe_8_E24", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_44_generated", "shape": null, "area": 0.64, "streetlevel": 966.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 966.79998779296875, "distance_right": 4.8889384698940225e-07, "index_right": 51, "nodeid": "1389482.451638_5859441.487986", "id": "1389482.451638_5859441.487986", "name": "manhole_44_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389482.45163832209073, 5859441.487986368127167 ] } }, +{ "type": "Feature", "properties": { "_index": 51, "bedlevel": 963.79998779296875, "branchid": "pipe_8_E24;pipe_8_E25", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_45_generated", "shape": null, "area": 0.64, "streetlevel": 966.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 966.79998779296875, "distance_right": 2.3478981975380763e-07, "index_right": 52, "nodeid": "1389497.215460_5859393.906834", "id": "1389497.215460_5859393.906834", "name": "manhole_45_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389497.215460168197751, 5859393.906833835877478 ] } }, +{ "type": "Feature", "properties": { "_index": 52, "bedlevel": 954.29998779296875, "branchid": "pipe_8_E25;pipe_8_E26", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_46_generated", "shape": null, "area": 0.64, "streetlevel": 957.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 957.29998779296875, "distance_right": 5.2209295831122375e-07, "index_right": 53, "nodeid": "1389508.394423_5859345.216127", "id": "1389508.394423_5859345.216127", "name": "manhole_46_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389508.394423164660111, 5859345.216126504354179 ] } }, +{ "type": "Feature", "properties": { "_index": 53, "bedlevel": 954.29998779296875, "branchid": "pipe_8_E26;pipe_8_E27", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_47_generated", "shape": null, "area": 0.64, "streetlevel": 957.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 957.29998779296875, "distance_right": 3.0133898611394186e-07, "index_right": 54, "nodeid": "1389518.522438_5859296.296715", "id": "1389518.522438_5859296.296715", "name": "manhole_47_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389518.522437864448875, 5859296.29671473056078 ] } }, +{ "type": "Feature", "properties": { "_index": 54, "bedlevel": 954.29998779296875, "branchid": "pipe_8_E27;pipe_8_E28", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_48_generated", "shape": null, "area": 0.64, "streetlevel": 957.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 957.29998779296875, "distance_right": 5.4884780991796183e-07, "index_right": 55, "nodeid": "1389528.588072_5859247.363728", "id": "1389528.588072_5859247.363728", "name": "manhole_48_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389528.588071504374966, 5859247.363727764226496 ] } }, +{ "type": "Feature", "properties": { "_index": 55, "bedlevel": 947.20001220703125, "branchid": "pipe_8_E28;pipe_8_E29", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_49_generated", "shape": null, "area": 0.64, "streetlevel": 950.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 950.20001220703125, "distance_right": 2.4911616766346636e-07, "index_right": 56, "nodeid": "1389538.653705_5859198.430741", "id": "1389538.653705_5859198.430741", "name": "manhole_49_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389538.653705144301057, 5859198.43074079696089 ] } }, +{ "type": "Feature", "properties": { "_index": 56, "bedlevel": 954.60003662109375, "branchid": "pipe_8_E29;pipe_8_E30", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_50_generated", "shape": null, "area": 0.64, "streetlevel": 957.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 957.60003662109375, "distance_right": 2.7425236063129317e-07, "index_right": 57, "nodeid": "1389548.719339_5859149.497754", "id": "1389548.719339_5859149.497754", "name": "manhole_50_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389548.719338784459978, 5859149.497753830626607 ] } }, +{ "type": "Feature", "properties": { "_index": 57, "bedlevel": 954.60003662109375, "branchid": "pipe_8_E30;pipe_8_E31", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_51_generated", "shape": null, "area": 0.64, "streetlevel": 957.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 957.60003662109375, "distance_right": 4.4598301075309513e-07, "index_right": 58, "nodeid": "1389558.784972_5859100.564767", "id": "1389558.784972_5859100.564767", "name": "manhole_51_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389558.784972424386069, 5859100.564766863361001 ] } }, +{ "type": "Feature", "properties": { "_index": 58, "bedlevel": 951.79998779296875, "branchid": "pipe_8_E31;pipe_8_E32", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_52_generated", "shape": null, "area": 0.64, "streetlevel": 954.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 954.79998779296875, "distance_right": 1.2172211470524948e-07, "index_right": 59, "nodeid": "1389568.850606_5859051.631780", "id": "1389568.850606_5859051.631780", "name": "manhole_52_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389568.85060606431216, 5859051.631779897026718 ] } }, +{ "type": "Feature", "properties": { "_index": 59, "bedlevel": 951.79998779296875, "branchid": "pipe_8_E32;pipe_8_E33", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_53_generated", "shape": null, "area": 0.64, "streetlevel": 954.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 954.79998779296875, "distance_right": 3.0360624912949541e-07, "index_right": 60, "nodeid": "1389578.916240_5859002.698793", "id": "1389578.916240_5859002.698793", "name": "manhole_53_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389578.916239704471081, 5859002.698792929761112 ] } }, +{ "type": "Feature", "properties": { "_index": 60, "bedlevel": 951.79998779296875, "branchid": "pipe_8_E33;pipe_8_E34", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_54_generated", "shape": null, "area": 0.64, "streetlevel": 954.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 954.79998779296875, "distance_right": 3.4626676338146224e-07, "index_right": 61, "nodeid": "1389588.981873_5858953.765806", "id": "1389588.981873_5858953.765806", "name": "manhole_54_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389588.981873344397172, 5858953.765805963426828 ] } }, +{ "type": "Feature", "properties": { "_index": 61, "bedlevel": 953.10003662109375, "branchid": "pipe_8_E34;pipe_8_E35", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_55_generated", "shape": null, "area": 0.64, "streetlevel": 956.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 956.10003662109375, "distance_right": 1.6038296836702642e-08, "index_right": 62, "nodeid": "1389599.047507_5858904.832819", "id": "1389599.047507_5858904.832819", "name": "manhole_55_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389599.047506984323263, 5858904.832818996161222 ] } }, +{ "type": "Feature", "properties": { "_index": 62, "bedlevel": 953.10003662109375, "branchid": "pipe_8_E35;pipe_8_E36", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_56_generated", "shape": null, "area": 0.64, "streetlevel": 956.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 956.10003662109375, "distance_right": 1.9577623893350078e-07, "index_right": 63, "nodeid": "1389613.243874_5858857.048414", "id": "1389613.243874_5858857.048414", "name": "manhole_56_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389613.243873829254881, 5858857.048414096236229 ] } }, +{ "type": "Feature", "properties": { "_index": 63, "bedlevel": 963.29998779296875, "branchid": "pipe_8_E36;pipe_8_E37", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_57_generated", "shape": null, "area": 0.64, "streetlevel": 966.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 966.29998779296875, "distance_right": 2.8036406150556381e-07, "index_right": 64, "nodeid": "1389631.198101_5858810.554778", "id": "1389631.198101_5858810.554778", "name": "manhole_57_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389631.198101107496768, 5858810.554778259247541 ] } }, +{ "type": "Feature", "properties": { "_index": 64, "bedlevel": 965.70001220703125, "branchid": "pipe_8_E37;pipe_8_E38", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_58_generated", "shape": null, "area": 0.64, "streetlevel": 968.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 968.70001220703125, "distance_right": 2.7015138015241521e-07, "index_right": 65, "nodeid": "1389656.490606_5858767.472956", "id": "1389656.490606_5858767.472956", "name": "manhole_58_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389656.490605737781152, 5858767.472956065088511 ] } }, +{ "type": "Feature", "properties": { "_index": 65, "bedlevel": 965.70001220703125, "branchid": "pipe_8_E38;pipe_8_E39", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_59_generated", "shape": null, "area": 0.64, "streetlevel": 968.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 968.70001220703125, "distance_right": 7.4150254667243819e-08, "index_right": 66, "nodeid": "1389681.956975_5858724.496400", "id": "1389681.956975_5858724.496400", "name": "manhole_59_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389681.956975018838421, 5858724.49639992788434 ] } }, +{ "type": "Feature", "properties": { "_index": 66, "bedlevel": 973.10003662109375, "branchid": "pipe_8_E39;pipe_8_E40", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_60_generated", "shape": null, "area": 0.64, "streetlevel": 976.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 976.10003662109375, "distance_right": 3.7195414941973146e-07, "index_right": 67, "nodeid": "1389708.407580_5858682.115748", "id": "1389708.407580_5858682.115748", "name": "manhole_60_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389708.407580326776952, 5858682.115747822448611 ] } }, +{ "type": "Feature", "properties": { "_index": 67, "bedlevel": 980.10003662109375, "branchid": "pipe_8_E40;pipe_8_E41", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_61_generated", "shape": null, "area": 0.64, "streetlevel": 983.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 983.10003662109375, "distance_right": 4.6218008783908108e-07, "index_right": 68, "nodeid": "1389734.858186_5858639.735096", "id": "1389734.858186_5858639.735096", "name": "manhole_61_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389734.858185634715483, 5858639.735095717012882 ] } }, +{ "type": "Feature", "properties": { "_index": 68, "bedlevel": 980.10003662109375, "branchid": "pipe_8_E41;pipe_8_E42", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_62_generated", "shape": null, "area": 0.64, "streetlevel": 983.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 983.10003662109375, "distance_right": 3.9348378777503967e-07, "index_right": 69, "nodeid": "1389761.308791_5858597.354444", "id": "1389761.308791_5858597.354444", "name": "manhole_62_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389761.308790942654014, 5858597.354443610645831 ] } }, +{ "type": "Feature", "properties": { "_index": 69, "bedlevel": 980.10003662109375, "branchid": "pipe_8_E42;pipe_8_E43", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_63_generated", "shape": null, "area": 0.64, "streetlevel": 983.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 983.10003662109375, "distance_right": 5.5447458020309209e-07, "index_right": 70, "nodeid": "1389787.759396_5858554.973792", "id": "1389787.759396_5858554.973792", "name": "manhole_63_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389787.759396250825375, 5858554.973791505210102 ] } }, +{ "type": "Feature", "properties": { "_index": 70, "bedlevel": 990.29998779296875, "branchid": "pipe_8_E43;pipe_8_E44", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_64_generated", "shape": null, "area": 0.64, "streetlevel": 993.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 993.29998779296875, "distance_right": 5.9523102820972942e-07, "index_right": 71, "nodeid": "1389814.210002_5858512.593139", "id": "1389814.210002_5858512.593139", "name": "manhole_64_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389814.210001558763906, 5858512.593139399774373 ] } }, +{ "type": "Feature", "properties": { "_index": 71, "bedlevel": 995.29998779296875, "branchid": "pipe_8_E44;pipe_8_E45", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_65_generated", "shape": null, "area": 0.64, "streetlevel": 998.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 998.29998779296875, "distance_right": 3.2227739481136277e-07, "index_right": 72, "nodeid": "1389840.660607_5858470.212487", "id": "1389840.660607_5858470.212487", "name": "manhole_65_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389840.660606866702437, 5858470.212487293407321 ] } }, +{ "type": "Feature", "properties": { "_index": 72, "bedlevel": 995.29998779296875, "branchid": "pipe_8_E45;pipe_8_E46", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_66_generated", "shape": null, "area": 0.64, "streetlevel": 998.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 998.29998779296875, "distance_right": 2.5668076370860681e-07, "index_right": 73, "nodeid": "1389867.111212_5858427.831835", "id": "1389867.111212_5858427.831835", "name": "manhole_66_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389867.111212174640968, 5858427.831835187971592 ] } }, +{ "type": "Feature", "properties": { "_index": 73, "bedlevel": 995.29998779296875, "branchid": "pipe_8_E46;pipe_8_E47", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_67_generated", "shape": null, "area": 0.64, "streetlevel": 998.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 998.29998779296875, "distance_right": 1.2468597271427185e-07, "index_right": 74, "nodeid": "1389911.240854_5858417.074702", "id": "1389911.240854_5858417.074702", "name": "manhole_67_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389911.240854029776528, 5858417.074701879173517 ] } }, +{ "type": "Feature", "properties": { "_index": 74, "bedlevel": 1003.2000122070312, "branchid": "pipe_8_E47;pipe_8_E48", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_68_generated", "shape": null, "area": 0.64, "streetlevel": 1006.2000122070312, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1006.2000122070312, "distance_right": 3.2574538134795858e-07, "index_right": 75, "nodeid": "1389940.226093_5858455.739662", "id": "1389940.226093_5858455.739662", "name": "manhole_68_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389940.226093058940023, 5858455.739661679603159 ] } }, +{ "type": "Feature", "properties": { "_index": 75, "bedlevel": 1003.2000122070312, "branchid": "pipe_8_E48;pipe_8_E49", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_69_generated", "shape": null, "area": 0.64, "streetlevel": 1006.2000122070312, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1006.2000122070312, "distance_right": 4.546962510023651e-07, "index_right": 76, "nodeid": "1389959.842267_5858501.684845", "id": "1389959.842267_5858501.684845", "name": "manhole_69_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389959.842267287895083, 5858501.684845351614058 ] } }, +{ "type": "Feature", "properties": { "_index": 76, "bedlevel": 1003.2000122070312, "branchid": "pipe_8_E49;pipe_8_E50", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_70_generated", "shape": null, "area": 0.64, "streetlevel": 1006.2000122070312, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1006.2000122070312, "distance_right": 4.3064103079185693e-07, "index_right": 77, "nodeid": "1389983.028927_5858544.760825", "id": "1389983.028927_5858544.760825", "name": "manhole_70_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389983.028926897095516, 5858544.760824581608176 ] } }, +{ "type": "Feature", "properties": { "_index": 77, "bedlevel": 1033.9000244140625, "branchid": "pipe_8_E50;pipe_8_E51", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_71_generated", "shape": null, "area": 0.64, "streetlevel": 1036.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1036.9000244140625, "distance_right": 4.1431531026563027e-07, "index_right": 78, "nodeid": "1390026.879799_5858567.986969", "id": "1390026.879799_5858567.986969", "name": "manhole_71_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390026.879799408372492, 5858567.986969069577754 ] } }, +{ "type": "Feature", "properties": { "_index": 78, "bedlevel": 1033.9000244140625, "branchid": "pipe_8_E51;pipe_8_E52", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_72_generated", "shape": null, "area": 0.64, "streetlevel": 1036.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1036.9000244140625, "distance_right": 2.9937059585548104e-07, "index_right": 79, "nodeid": "1390075.455720_5858577.981818", "id": "1390075.455720_5858577.981818", "name": "manhole_72_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390075.455719914287329, 5858577.981817713007331 ] } }, +{ "type": "Feature", "properties": { "_index": 79, "bedlevel": 1029.9000244140625, "branchid": "pipe_8_E52;pipe_8_E53", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_73_generated", "shape": null, "area": 0.64, "streetlevel": 1032.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1032.9000244140625, "distance_right": 6.3999973011019791e-07, "index_right": 80, "nodeid": "1390124.934820_5858584.860858", "id": "1390124.934820_5858584.860858", "name": "manhole_73_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390124.934819511603564, 5858584.860858413390815 ] } }, +{ "type": "Feature", "properties": { "_index": 80, "bedlevel": 1029.9000244140625, "branchid": "pipe_8_E53;pipe_8_E54", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_74_generated", "shape": null, "area": 0.64, "streetlevel": 1032.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1032.9000244140625, "distance_right": 5.6459971675126326e-07, "index_right": 81, "nodeid": "1390174.385966_5858591.894069", "id": "1390174.385966_5858591.894069", "name": "manhole_74_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390174.385966305155307, 5858591.894069475121796 ] } }, +{ "type": "Feature", "properties": { "_index": 81, "bedlevel": 1013.6000366210938, "branchid": "pipe_8_E54;pipe_8_E55", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_75_generated", "shape": null, "area": 0.64, "streetlevel": 1016.6000366210938, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1016.6000366210938, "distance_right": 5.1654411025583547e-07, "index_right": 82, "nodeid": "1390224.287318_5858594.262458", "id": "1390224.287318_5858594.262458", "name": "manhole_75_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390224.28731826832518, 5858594.262458441779017 ] } }, +{ "type": "Feature", "properties": { "_index": 82, "bedlevel": 1013.6000366210938, "branchid": "pipe_8_E55;pipe_8_E56", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_76_generated", "shape": null, "area": 0.64, "streetlevel": 1016.6000366210938, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1016.6000366210938, "distance_right": 3.9007138584381877e-07, "index_right": 83, "nodeid": "1390273.630286_5858589.561946", "id": "1390273.630286_5858589.561946", "name": "manhole_76_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390273.630285855382681, 5858589.561945637688041 ] } }, +{ "type": "Feature", "properties": { "_index": 83, "bedlevel": 1009.1000366210938, "branchid": "pipe_8_E56;pipe_8_E57", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_77_generated", "shape": null, "area": 0.64, "streetlevel": 1012.1000366210938, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1012.1000366210938, "distance_right": 3.7797421488348324e-07, "index_right": 84, "nodeid": "1390322.239480_5858578.072307", "id": "1390322.239480_5858578.072307", "name": "manhole_77_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390322.239480242831632, 5858578.072306710295379 ] } }, +{ "type": "Feature", "properties": { "_index": 84, "bedlevel": 1009.1000366210938, "branchid": "pipe_8_E57;pipe_8_E58", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_78_generated", "shape": null, "area": 0.64, "streetlevel": 1012.1000366210938, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1012.1000366210938, "distance_right": 2.4273697310930584e-07, "index_right": 85, "nodeid": "1390371.993529_5858575.309523", "id": "1390371.993529_5858575.309523", "name": "manhole_78_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390371.99352877959609, 5858575.309522898867726 ] } }, +{ "type": "Feature", "properties": { "_index": 85, "bedlevel": 1008.7000122070312, "branchid": "pipe_8_E58;pipe_8_E59", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_79_generated", "shape": null, "area": 0.64, "streetlevel": 1011.7000122070312, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1011.7000122070312, "distance_right": 4.4565761900705597e-07, "index_right": 86, "nodeid": "1390419.135442_5858559.593115", "id": "1390419.135442_5858559.593115", "name": "manhole_79_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390419.13544210139662, 5858559.59311543405056 ] } }, +{ "type": "Feature", "properties": { "_index": 86, "bedlevel": 978.5, "branchid": "pipe_8_E59;pipe_8_E60", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_80_generated", "shape": null, "area": 0.64, "streetlevel": 981.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 981.5, "distance_right": 3.9297405447244982e-07, "index_right": 87, "nodeid": "1390453.401624_5858524.246224", "id": "1390453.401624_5858524.246224", "name": "manhole_80_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390453.401623640675098, 5858524.246223840862513 ] } }, +{ "type": "Feature", "properties": { "_index": 87, "bedlevel": 992.70001220703125, "branchid": "pipe_8_E60;pipe_8_E61", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_81_generated", "shape": null, "area": 0.64, "streetlevel": 995.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 995.70001220703125, "distance_right": 2.7019040680695823e-07, "index_right": 88, "nodeid": "1390496.749500_5858504.780009", "id": "1390496.749500_5858504.780009", "name": "manhole_81_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390496.749499944737181, 5858504.780008735135198 ] } }, +{ "type": "Feature", "properties": { "_index": 88, "bedlevel": 992.70001220703125, "branchid": "pipe_8_E61;pipe_8_E62", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_82_generated", "shape": null, "area": 0.64, "streetlevel": 995.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 995.70001220703125, "distance_right": 3.9802689654992729e-07, "index_right": 89, "nodeid": "1390546.470755_5858499.993152", "id": "1390546.470755_5858499.993152", "name": "manhole_82_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390546.470755147282034, 5858499.993151630274951 ] } }, +{ "type": "Feature", "properties": { "_index": 89, "bedlevel": 1002.9000244140625, "branchid": "pipe_8_E62;pipe_8_E63", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_83_generated", "shape": null, "area": 0.64, "streetlevel": 1005.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1005.9000244140625, "distance_right": 2.4497368864862642e-07, "index_right": 90, "nodeid": "1390596.395264_5858498.177226", "id": "1390596.395264_5858498.177226", "name": "manhole_83_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390596.395264241611585, 5858498.177226040512323 ] } }, +{ "type": "Feature", "properties": { "_index": 90, "bedlevel": 1002.9000244140625, "branchid": "pipe_8_E63;pipe_8_E64", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_84_generated", "shape": null, "area": 0.64, "streetlevel": 1005.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1005.9000244140625, "distance_right": 5.630813563551087e-07, "index_right": 91, "nodeid": "1390646.319773_5858496.361300", "id": "1390646.319773_5858496.361300", "name": "manhole_84_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390646.319773336173967, 5858496.361300451681018 ] } }, +{ "type": "Feature", "properties": { "_index": 91, "bedlevel": 1010.6000366210938, "branchid": "pipe_8_E64;pipe_8_E65", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_85_generated", "shape": null, "area": 0.64, "streetlevel": 1013.6000366210938, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1013.6000366210938, "distance_right": 4.5174815259276067e-07, "index_right": 92, "nodeid": "1390696.244282_5858494.545375", "id": "1390696.244282_5858494.545375", "name": "manhole_85_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390696.244282430503517, 5858494.545374862849712 ] } }, +{ "type": "Feature", "properties": { "_index": 92, "bedlevel": 1010.6000366210938, "branchid": "pipe_8_E65;pipe_8_E66", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_86_generated", "shape": null, "area": 0.64, "streetlevel": 1013.6000366210938, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1013.6000366210938, "distance_right": 5.4798189509202394e-07, "index_right": 93, "nodeid": "1390746.168792_5858492.729449", "id": "1390746.168792_5858492.729449", "name": "manhole_86_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390746.168791524833068, 5858492.729449273087084 ] } }, +{ "type": "Feature", "properties": { "_index": 93, "bedlevel": 1016.1000366210938, "branchid": "pipe_8_E66;pipe_8_E67", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_87_generated", "shape": null, "area": 0.64, "streetlevel": 1019.1000366210938, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1019.1000366210938, "distance_right": 4.9456434962347771e-07, "index_right": 94, "nodeid": "1390796.093301_5858490.913524", "id": "1390796.093301_5858490.913524", "name": "manhole_87_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390796.09330061939545, 5858490.913523684255779 ] } }, +{ "type": "Feature", "properties": { "_index": 94, "bedlevel": 1022.800048828125, "branchid": "pipe_8_E67;pipe_8_E68", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_88_generated", "shape": null, "area": 0.64, "streetlevel": 1025.800048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1025.800048828125, "distance_right": 3.0172587701371808e-07, "index_right": 95, "nodeid": "1390846.017810_5858489.097598", "id": "1390846.017810_5858489.097598", "name": "manhole_88_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390846.017809713725001, 5858489.097598095424473 ] } }, +{ "type": "Feature", "properties": { "_index": 95, "bedlevel": 1022.800048828125, "branchid": "pipe_8_E68;pipe_8_E69", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_89_generated", "shape": null, "area": 0.64, "streetlevel": 1025.800048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1025.800048828125, "distance_right": 5.3044278269972165e-07, "index_right": 96, "nodeid": "1390895.942319_5858487.281673", "id": "1390895.942319_5858487.281673", "name": "manhole_89_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390895.942318808054551, 5858487.281672505661845 ] } }, +{ "type": "Feature", "properties": { "_index": 96, "bedlevel": 1026.2000732421875, "branchid": "pipe_8_E69;pipe_8_E70", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_90_generated", "shape": null, "area": 0.64, "streetlevel": 1029.2000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1029.2000732421875, "distance_right": 3.6479034128509556e-07, "index_right": 97, "nodeid": "1390945.364988_5858492.061226", "id": "1390945.364988_5858492.061226", "name": "manhole_90_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390945.364988021552563, 5858492.061225635930896 ] } }, +{ "type": "Feature", "properties": { "_index": 97, "bedlevel": 1026.2000732421875, "branchid": "pipe_8_E70;pipe_8_E71", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_91_generated", "shape": null, "area": 0.64, "streetlevel": 1029.2000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1029.2000732421875, "distance_right": 4.3568107187541058e-07, "index_right": 98, "nodeid": "1390994.440002_5858501.409873", "id": "1390994.440002_5858501.409873", "name": "manhole_91_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390994.440001817885786, 5858501.409873396158218 ] } }, +{ "type": "Feature", "properties": { "_index": 98, "bedlevel": 1030.2000732421875, "branchid": "pipe_8_E71;pipe_8_E72", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_92_generated", "shape": null, "area": 0.64, "streetlevel": 1033.2000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1033.2000732421875, "distance_right": 2.741891005169924e-07, "index_right": 99, "nodeid": "1391040.341197_5858520.979841", "id": "1391040.341197_5858520.979841", "name": "manhole_92_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391040.341196772176772, 5858520.979841153137386 ] } }, +{ "type": "Feature", "properties": { "_index": 99, "bedlevel": 1030.2000732421875, "branchid": "pipe_8_E72;pipe_8_E73", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_93_generated", "shape": null, "area": 0.64, "streetlevel": 1033.2000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1033.2000732421875, "distance_right": 8.732235612425121e-08, "index_right": 100, "nodeid": "1391086.683747_5858538.717575", "id": "1391086.683747_5858538.717575", "name": "manhole_93_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391086.683747049886733, 5858538.717575071379542 ] } }, +{ "type": "Feature", "properties": { "_index": 100, "bedlevel": 1035.2000732421875, "branchid": "pipe_8_E73;pipe_8_E74", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_94_generated", "shape": null, "area": 0.64, "streetlevel": 1038.2000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1038.2000732421875, "distance_right": 2.5924414027713618e-07, "index_right": 101, "nodeid": "1391131.822940_5858523.932432", "id": "1391131.822940_5858523.932432", "name": "manhole_94_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391131.822940095094964, 5858523.93243224080652 ] } }, +{ "type": "Feature", "properties": { "_index": 101, "bedlevel": 1035.2000732421875, "branchid": "pipe_8_E74;pipe_8_E75", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_95_generated", "shape": null, "area": 0.64, "streetlevel": 1038.2000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1038.2000732421875, "distance_right": 1.3213318521127537e-07, "index_right": 102, "nodeid": "1391153.157672_5858479.460671", "id": "1391153.157672_5858479.460671", "name": "manhole_95_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391153.157672074623406, 5858479.460670891217887 ] } }, +{ "type": "Feature", "properties": { "_index": 102, "bedlevel": 1035.2000732421875, "branchid": "pipe_8_E75;pipe_8_E76", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_96_generated", "shape": null, "area": 0.64, "streetlevel": 1038.2000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1038.2000732421875, "distance_right": 6.7824090023605347e-08, "index_right": 103, "nodeid": "1391192.495906_5858451.678392", "id": "1391192.495906_5858451.678392", "name": "manhole_96_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391192.49590603238903, 5858451.67839205916971 ] } }, +{ "type": "Feature", "properties": { "_index": 103, "bedlevel": 1041.2000732421875, "branchid": "pipe_8_E76;pipe_8_E77", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_97_generated", "shape": null, "area": 0.64, "streetlevel": 1044.2000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1044.2000732421875, "distance_right": 4.4386974600926325e-07, "index_right": 104, "nodeid": "1391240.641174_5858438.460245", "id": "1391240.641174_5858438.460245", "name": "manhole_97_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391240.64117361814715, 5858438.460245226509869 ] } }, +{ "type": "Feature", "properties": { "_index": 104, "bedlevel": 1041.2000732421875, "branchid": "pipe_8_E77;pipe_8_E78", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_98_generated", "shape": null, "area": 0.64, "streetlevel": 1044.2000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1044.2000732421875, "distance_right": 4.0992187190293211e-07, "index_right": 105, "nodeid": "1391289.211760_5858426.770406", "id": "1391289.211760_5858426.770406", "name": "manhole_98_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391289.211760010803118, 5858426.770406410098076 ] } }, +{ "type": "Feature", "properties": { "_index": 105, "bedlevel": 1057.0999755859375, "branchid": "pipe_8_E78;pipe_8_E79", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_99_generated", "shape": null, "area": 0.64, "streetlevel": 1060.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1060.0999755859375, "distance_right": 5.7227858761127112e-07, "index_right": 106, "nodeid": "1391337.782346_5858415.080568", "id": "1391337.782346_5858415.080568", "name": "manhole_99_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391337.782346403226256, 5858415.080567593686283 ] } }, +{ "type": "Feature", "properties": { "_index": 106, "bedlevel": 1020.0, "branchid": "pipe_8_E79;pipe_8_E80", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_100_generated", "shape": null, "area": 0.64, "streetlevel": 1023.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1023.0, "distance_right": 3.0205816736469116e-07, "index_right": 107, "nodeid": "1391386.352933_5858403.390729", "id": "1391386.352933_5858403.390729", "name": "manhole_100_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391386.352932795882225, 5858403.390728777274489 ] } }, +{ "type": "Feature", "properties": { "_index": 107, "bedlevel": 1029.7000732421875, "branchid": "pipe_8_E80;pipe_8_E81", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_101_generated", "shape": null, "area": 0.64, "streetlevel": 1032.7000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1032.7000732421875, "distance_right": 1.9219136604978585e-07, "index_right": 108, "nodeid": "1391434.923519_5858391.700890", "id": "1391434.923519_5858391.700890", "name": "manhole_101_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391434.923519188305363, 5858391.700889961794019 ] } }, +{ "type": "Feature", "properties": { "_index": 108, "bedlevel": 1029.7000732421875, "branchid": "pipe_8_E81;pipe_8_E82", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_102_generated", "shape": null, "area": 0.64, "streetlevel": 1032.7000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1032.7000732421875, "distance_right": 4.4356382539420129e-07, "index_right": 109, "nodeid": "1391483.494106_5858380.011051", "id": "1391483.494106_5858380.011051", "name": "manhole_102_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391483.494105580961332, 5858380.011051145382226 ] } }, +{ "type": "Feature", "properties": { "_index": 109, "bedlevel": 1037.7000732421875, "branchid": "pipe_8_E82;pipe_8_E83", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_103_generated", "shape": null, "area": 0.64, "streetlevel": 1040.7000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1040.7000732421875, "distance_right": 3.7088810712096512e-07, "index_right": 110, "nodeid": "1391532.464345_5858375.802092", "id": "1391532.464345_5858375.802092", "name": "manhole_103_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391532.464345134794712, 5858375.802092345431447 ] } }, +{ "type": "Feature", "properties": { "_index": 110, "bedlevel": 1037.7000732421875, "branchid": "pipe_8_E83;pipe_8_E84", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_104_generated", "shape": null, "area": 0.64, "streetlevel": 1040.7000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1040.7000732421875, "distance_right": 4.6015352769437255e-07, "index_right": 111, "nodeid": "1391579.680509_5858389.753166", "id": "1391579.680509_5858389.753166", "name": "manhole_104_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391579.680508555145934, 5858389.753166117705405 ] } }, +{ "type": "Feature", "properties": { "_index": 111, "bedlevel": 1091.5999755859375, "branchid": "pipe_8_E84;pipe_8_E85", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_105_generated", "shape": null, "area": 0.64, "streetlevel": 1094.5999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1094.5999755859375, "distance_right": 3.7281072118280933e-07, "index_right": 112, "nodeid": "1391615.043222_5858422.374544", "id": "1391615.043222_5858422.374544", "name": "manhole_105_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391615.043221722124144, 5858422.374543751589954 ] } }, +{ "type": "Feature", "properties": { "_index": 112, "bedlevel": 1091.5999755859375, "branchid": "pipe_8_E85;pipe_8_E86", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_106_generated", "shape": null, "area": 0.64, "streetlevel": 1094.5999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1094.5999755859375, "distance_right": 2.2872503157110954e-07, "index_right": 113, "nodeid": "1391633.654096_5858468.206738", "id": "1391633.654096_5858468.206738", "name": "manhole_106_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391633.654095822479576, 5858468.206737855449319 ] } }, +{ "type": "Feature", "properties": { "_index": 113, "bedlevel": 1091.5999755859375, "branchid": "pipe_8_E86;pipe_8_E87", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_107_generated", "shape": null, "area": 0.64, "streetlevel": 1094.5999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1094.5999755859375, "distance_right": 9.072182616041515e-08, "index_right": 114, "nodeid": "1391675.556872_5858492.042519", "id": "1391675.556872_5858492.042519", "name": "manhole_107_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391675.556871910346672, 5858492.042518986389041 ] } }, +{ "type": "Feature", "properties": { "_index": 114, "bedlevel": 1097.5999755859375, "branchid": "pipe_8_E87;pipe_8_E88", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_108_generated", "shape": null, "area": 0.64, "streetlevel": 1100.5999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1100.5999755859375, "distance_right": 4.4979023780430931e-07, "index_right": 115, "nodeid": "1391725.165285_5858493.223411", "id": "1391725.165285_5858493.223411", "name": "manhole_108_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391725.165284683462232, 5858493.223410680890083 ] } }, +{ "type": "Feature", "properties": { "_index": 115, "bedlevel": 1089.7000732421875, "branchid": "pipe_8_E88;pipe_8_E89", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_109_generated", "shape": null, "area": 0.64, "streetlevel": 1092.7000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1092.7000732421875, "distance_right": 6.1507933656501941e-07, "index_right": 116, "nodeid": "1391774.025633_5858482.968163", "id": "1391774.025633_5858482.968163", "name": "manhole_109_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391774.025632579578087, 5858482.968163449317217 ] } }, +{ "type": "Feature", "properties": { "_index": 116, "bedlevel": 1089.7000732421875, "branchid": "pipe_8_E89;pipe_8_E90", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_110_generated", "shape": null, "area": 0.64, "streetlevel": 1092.7000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1092.7000732421875, "distance_right": 4.4649032319595157e-07, "index_right": 117, "nodeid": "1391822.748904_5858472.800456", "id": "1391822.748904_5858472.800456", "name": "manhole_110_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391822.748904443578795, 5858472.800456050783396 ] } }, +{ "type": "Feature", "properties": { "_index": 117, "bedlevel": 1083.5, "branchid": "pipe_8_E90;pipe_8_E91", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_111_generated", "shape": null, "area": 0.64, "streetlevel": 1086.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1086.5, "distance_right": 5.1775132957041802e-07, "index_right": 118, "nodeid": "1391872.520156_5858474.254767", "id": "1391872.520156_5858474.254767", "name": "manhole_111_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391872.520155652426183, 5858474.254766616038978 ] } }, +{ "type": "Feature", "properties": { "_index": 118, "bedlevel": 1083.5, "branchid": "pipe_8_E91;pipe_8_E92", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_112_generated", "shape": null, "area": 0.64, "streetlevel": 1086.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1086.5, "distance_right": 4.4541475797890906e-07, "index_right": 119, "nodeid": "1391922.328207_5858478.116395", "id": "1391922.328207_5858478.116395", "name": "manhole_112_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391922.32820742437616, 5858478.116394865326583 ] } }, +{ "type": "Feature", "properties": { "_index": 119, "bedlevel": 1094.300048828125, "branchid": "pipe_8_E92;pipe_8_E93", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_113_generated", "shape": null, "area": 0.64, "streetlevel": 1097.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1097.300048828125, "distance_right": 2.2746016721836874e-07, "index_right": 120, "nodeid": "1391972.136259_5858481.978023", "id": "1391972.136259_5858481.978023", "name": "manhole_113_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391972.136259196558967, 5858481.978023114614189 ] } }, +{ "type": "Feature", "properties": { "_index": 120, "bedlevel": 1094.300048828125, "branchid": "pipe_8_E93;pipe_8_E94", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_114_generated", "shape": null, "area": 0.64, "streetlevel": 1097.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1097.300048828125, "distance_right": 3.2100414121190839e-07, "index_right": 121, "nodeid": "1392014.088138_5858507.265421", "id": "1392014.088138_5858507.265421", "name": "manhole_114_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392014.088137687649578, 5858507.265420926734805 ] } }, +{ "type": "Feature", "properties": { "_index": 121, "bedlevel": 1094.300048828125, "branchid": "pipe_8_E94;pipe_8_E95", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_115_generated", "shape": null, "area": 0.64, "streetlevel": 1097.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1097.300048828125, "distance_right": 2.1114543171142478e-07, "index_right": 122, "nodeid": "1392052.005776_5858538.949621", "id": "1392052.005776_5858538.949621", "name": "manhole_115_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392052.00577615830116, 5858538.949620860628784 ] } }, +{ "type": "Feature", "properties": { "_index": 122, "bedlevel": 1094.300048828125, "branchid": "pipe_8_E95;pipe_8_E96", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_116_generated", "shape": null, "area": 0.64, "streetlevel": 1097.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1097.300048828125, "distance_right": 5.0401854604332595e-07, "index_right": 123, "nodeid": "1392100.993319_5858548.746294", "id": "1392100.993319_5858548.746294", "name": "manhole_116_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392100.993319420609623, 5858548.746293722651899 ] } }, +{ "type": "Feature", "properties": { "_index": 123, "bedlevel": 1132.300048828125, "branchid": "pipe_8_E96;pipe_8_E97", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_117_generated", "shape": null, "area": 0.64, "streetlevel": 1135.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1135.300048828125, "distance_right": 5.2170281845336017e-07, "index_right": 124, "nodeid": "1392149.980863_5858558.542967", "id": "1392149.980863_5858558.542967", "name": "manhole_117_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392149.980862683150917, 5858558.542966585606337 ] } }, +{ "type": "Feature", "properties": { "_index": 124, "bedlevel": 1132.300048828125, "branchid": "pipe_8_E97;pipe_8_E98", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_118_generated", "shape": null, "area": 0.64, "streetlevel": 1135.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1135.300048828125, "distance_right": 4.4445564759065617e-07, "index_right": 125, "nodeid": "1392198.767288_5858569.252067", "id": "1392198.767288_5858569.252067", "name": "manhole_118_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392198.767287699971348, 5858569.25206732749939 ] } }, +{ "type": "Feature", "properties": { "_index": 125, "bedlevel": 1134.5999755859375, "branchid": "pipe_8_E98;pipe_8_E99", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_119_generated", "shape": null, "area": 0.64, "streetlevel": 1137.5999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1137.5999755859375, "distance_right": 4.7301835974406382e-07, "index_right": 126, "nodeid": "1392247.333907_5858580.958378", "id": "1392247.333907_5858580.958378", "name": "manhole_119_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392247.333906656363979, 5858580.958378325216472 ] } }, +{ "type": "Feature", "properties": { "_index": 126, "bedlevel": 1134.5999755859375, "branchid": "pipe_8_E99;pipe_8_E100", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_120_generated", "shape": null, "area": 0.64, "streetlevel": 1137.5999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1137.5999755859375, "distance_right": 5.0475986687146605e-07, "index_right": 127, "nodeid": "1392295.900526_5858592.664689", "id": "1392295.900526_5858592.664689", "name": "manhole_120_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392295.900525612989441, 5858592.664689323864877 ] } }, +{ "type": "Feature", "properties": { "_index": 127, "bedlevel": 1142.0999755859375, "branchid": "pipe_8_E100;pipe_8_E101", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_121_generated", "shape": null, "area": 0.64, "streetlevel": 1145.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1145.0999755859375, "distance_right": 5.375595191494766e-07, "index_right": 128, "nodeid": "1392344.467145_5858604.371000", "id": "1392344.467145_5858604.371000", "name": "manhole_121_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392344.467144569614902, 5858604.371000322513282 ] } }, +{ "type": "Feature", "properties": { "_index": 128, "bedlevel": 1142.0999755859375, "branchid": "pipe_8_E101;pipe_8_E102", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_122_generated", "shape": null, "area": 0.64, "streetlevel": 1145.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1145.0999755859375, "distance_right": 2.4497368864862642e-07, "index_right": 129, "nodeid": "1392389.908256_5858624.575614", "id": "1392389.908256_5858624.575614", "name": "manhole_122_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392389.908255772199482, 5858624.575613909401 ] } }, +{ "type": "Feature", "properties": { "_index": 129, "bedlevel": 1137.5, "branchid": "pipe_8_E102;pipe_8_E103", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_123_generated", "shape": null, "area": 0.64, "streetlevel": 1140.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1140.5, "distance_right": 6.1951662367235888e-07, "index_right": 130, "nodeid": "1392425.081700_5858659.315580", "id": "1392425.081700_5858659.315580", "name": "manhole_123_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392425.081700494978577, 5858659.315580372698605 ] } }, +{ "type": "Feature", "properties": { "_index": 130, "bedlevel": 1166.300048828125, "branchid": "pipe_8_E103;pipe_8_E104", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_124_generated", "shape": null, "area": 0.64, "streetlevel": 1169.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1169.300048828125, "distance_right": 4.961599164442623e-07, "index_right": 131, "nodeid": "1392458.203119_5858696.715123", "id": "1392458.203119_5858696.715123", "name": "manhole_124_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392458.203119478421286, 5858696.715123130939901 ] } }, +{ "type": "Feature", "properties": { "_index": 131, "bedlevel": 1166.300048828125, "branchid": "pipe_8_E104;pipe_8_E105", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_125_generated", "shape": null, "area": 0.64, "streetlevel": 1169.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1169.300048828125, "distance_right": 4.7482840076464003e-07, "index_right": 132, "nodeid": "1392491.324538_5858734.114666", "id": "1392491.324538_5858734.114666", "name": "manhole_125_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392491.324538461863995, 5858734.114665890112519 ] } }, +{ "type": "Feature", "properties": { "_index": 132, "bedlevel": 1162.5, "branchid": "pipe_8_E105;pipe_8_E106", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_126_generated", "shape": null, "area": 0.64, "streetlevel": 1165.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1165.5, "distance_right": 3.1541772764253496e-07, "index_right": 133, "nodeid": "1392528.963966_5858766.460637", "id": "1392528.963966_5858766.460637", "name": "manhole_126_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392528.963966277893633, 5858766.460637149401009 ] } }, +{ "type": "Feature", "properties": { "_index": 133, "bedlevel": 1162.5, "branchid": "pipe_8_E106;pipe_8_E107", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_127_generated", "shape": null, "area": 0.64, "streetlevel": 1165.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1165.5, "distance_right": 2.530020739658982e-07, "index_right": 134, "nodeid": "1392573.284122_5858789.391093", "id": "1392573.284122_5858789.391093", "name": "manhole_127_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392573.284122244687751, 5858789.391092935577035 ] } }, +{ "type": "Feature", "properties": { "_index": 134, "bedlevel": 1154.0999755859375, "branchid": "pipe_8_E107;pipe_8_E108", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_128_generated", "shape": null, "area": 0.64, "streetlevel": 1157.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1157.0999755859375, "distance_right": 4.2339034603252275e-07, "index_right": 135, "nodeid": "1392618.033192_5858811.600886", "id": "1392618.033192_5858811.600886", "name": "manhole_128_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392618.033192394766957, 5858811.600886153057218 ] } }, +{ "type": "Feature", "properties": { "_index": 135, "bedlevel": 1181.800048828125, "branchid": "pipe_8_E108;pipe_8_E109", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_129_generated", "shape": null, "area": 0.64, "streetlevel": 1184.800048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1184.800048828125, "distance_right": 1.9266352396909839e-07, "index_right": 136, "nodeid": "1392666.730896_5858821.011834", "id": "1392666.730896_5858821.011834", "name": "manhole_129_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392666.730896146036685, 5858821.011833874508739 ] } }, +{ "type": "Feature", "properties": { "_index": 136, "bedlevel": 1138.2000732421875, "branchid": "pipe_8_E109;pipe_8_E110", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_130_generated", "shape": null, "area": 0.64, "streetlevel": 1141.2000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1141.2000732421875, "distance_right": 2.6027935522375354e-07, "index_right": 137, "nodeid": "1392714.397227_5858809.184478", "id": "1392714.397227_5858809.184478", "name": "manhole_130_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392714.397227015113458, 5858809.184477739967406 ] } }, +{ "type": "Feature", "properties": { "_index": 137, "bedlevel": 1138.2000732421875, "branchid": "pipe_8_E110;pipe_8_E111", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_131_generated", "shape": null, "area": 0.64, "streetlevel": 1141.2000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1141.2000732421875, "distance_right": 1.8147785838056748e-07, "index_right": 138, "nodeid": "1392761.799295_5858794.231294", "id": "1392761.799295_5858794.231294", "name": "manhole_131_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392761.799294820055366, 5858794.231293976306915 ] } }, +{ "type": "Feature", "properties": { "_index": 138, "bedlevel": 1134.4000244140625, "branchid": "pipe_8_E111;pipe_8_E112", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_132_generated", "shape": null, "area": 0.64, "streetlevel": 1137.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1137.4000244140625, "distance_right": 2.5613275709078171e-07, "index_right": 139, "nodeid": "1392810.095713_5858797.830353", "id": "1392810.095713_5858797.830353", "name": "manhole_132_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392810.095712865469977, 5858797.830352782271802 ] } }, +{ "type": "Feature", "properties": { "_index": 139, "bedlevel": 1134.4000244140625, "branchid": "pipe_8_E112;pipe_8_E113", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_133_generated", "shape": null, "area": 0.64, "streetlevel": 1137.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1137.4000244140625, "distance_right": 2.0095334863222291e-07, "index_right": 140, "nodeid": "1392855.660074_5858817.529771", "id": "1392855.660074_5858817.529771", "name": "manhole_133_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392855.660074200481176, 5858817.529770986177027 ] } }, +{ "type": "Feature", "properties": { "_index": 140, "bedlevel": 1166.5, "branchid": "pipe_8_E113;pipe_8_E114", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_134_generated", "shape": null, "area": 0.64, "streetlevel": 1169.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1169.5, "distance_right": 1.7695128917694092e-07, "index_right": 141, "nodeid": "1392904.672455_5858826.347065", "id": "1392904.672455_5858826.347065", "name": "manhole_134_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392904.672455, 5858826.347064822912216 ] } }, +{ "type": "Feature", "properties": { "_index": 141, "bedlevel": 1166.5, "branchid": "pipe_8_E114;pipe_8_E115", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_135_generated", "shape": null, "area": 0.64, "streetlevel": 1169.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1169.5, "distance_right": 4.2239046795471208e-07, "index_right": 142, "nodeid": "1392949.505033_5858846.393358", "id": "1392949.505033_5858846.393358", "name": "manhole_135_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392949.505032581742853, 5858846.393358059227467 ] } }, +{ "type": "Feature", "properties": { "_index": 142, "bedlevel": 1166.5, "branchid": "pipe_8_E115;pipe_8_E116", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_136_generated", "shape": null, "area": 0.64, "streetlevel": 1169.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1169.5, "distance_right": 4.7343585218773503e-07, "index_right": 143, "nodeid": "1392993.956313_5858868.358838", "id": "1392993.956313_5858868.358838", "name": "manhole_136_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392993.956312821945176, 5858868.358838438987732 ] } }, +{ "type": "Feature", "properties": { "_index": 143, "bedlevel": 1166.5, "branchid": "pipe_8_E116;pipe_8_E117", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_137_generated", "shape": null, "area": 0.64, "streetlevel": 1169.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1169.5, "distance_right": 3.5917098364593396e-07, "index_right": 144, "nodeid": "1393042.160067_5858881.479520", "id": "1393042.160067_5858881.479520", "name": "manhole_137_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393042.160067020915449, 5858881.479519641026855 ] } }, +{ "type": "Feature", "properties": { "_index": 144, "bedlevel": 1159.0, "branchid": "pipe_8_E117;pipe_8_E118", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_138_generated", "shape": null, "area": 0.64, "streetlevel": 1162.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1162.0, "distance_right": 2.7014626312928133e-07, "index_right": 145, "nodeid": "1393090.363821_5858894.600201", "id": "1393090.363821_5858894.600201", "name": "manhole_138_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393090.363821219652891, 5858894.600200843065977 ] } }, +{ "type": "Feature", "properties": { "_index": 145, "bedlevel": 1159.0, "branchid": "pipe_8_E118;pipe_8_E119", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_139_generated", "shape": null, "area": 0.64, "streetlevel": 1162.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1162.0, "distance_right": 2.7132603156118906e-07, "index_right": 146, "nodeid": "1393138.877780_5858905.382868", "id": "1393138.877780_5858905.382868", "name": "manhole_139_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393138.877780271228403, 5858905.382868006825447 ] } }, +{ "type": "Feature", "properties": { "_index": 146, "bedlevel": 1149.0999755859375, "branchid": "pipe_8_E119;pipe_8_E120", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_140_generated", "shape": null, "area": 0.64, "streetlevel": 1152.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1152.0999755859375, "distance_right": 4.4714856881835964e-07, "index_right": 147, "nodeid": "1393188.835210_5858905.286093", "id": "1393188.835210_5858905.286093", "name": "manhole_140_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393188.835210436256602, 5858905.286093098111451 ] } }, +{ "type": "Feature", "properties": { "_index": 147, "bedlevel": 1149.0999755859375, "branchid": "pipe_8_E120;pipe_8_E121", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_141_generated", "shape": null, "area": 0.64, "streetlevel": 1152.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1152.0999755859375, "distance_right": 4.1288226393878735e-07, "index_right": 148, "nodeid": "1393237.248238_5858916.599204", "id": "1393237.248238_5858916.599204", "name": "manhole_141_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393237.248238409170881, 5858916.599204055964947 ] } }, +{ "type": "Feature", "properties": { "_index": 148, "bedlevel": 1144.300048828125, "branchid": "pipe_8_E121;pipe_8_E122", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_142_generated", "shape": null, "area": 0.64, "streetlevel": 1147.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1147.300048828125, "distance_right": 5.0644962812498666e-07, "index_right": 149, "nodeid": "1393278.156388_5858943.766048", "id": "1393278.156388_5858943.766048", "name": "manhole_142_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393278.15638761385344, 5858943.766047672368586 ] } }, +{ "type": "Feature", "properties": { "_index": 149, "bedlevel": 1179.7000732421875, "branchid": "pipe_8_E122;pipe_8_E123", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_143_generated", "shape": null, "area": 0.64, "streetlevel": 1182.7000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1182.7000732421875, "distance_right": 3.9671280876034223e-07, "index_right": 150, "nodeid": "1393316.553906_5858975.725159", "id": "1393316.553906_5858975.725159", "name": "manhole_143_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393316.553906054003164, 5858975.725158606655896 ] } }, +{ "type": "Feature", "properties": { "_index": 150, "bedlevel": 1177.0999755859375, "branchid": "pipe_8_E123;pipe_8_E124", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_144_generated", "shape": null, "area": 0.64, "streetlevel": 1180.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1180.0999755859375, "distance_right": 6.7527730730815987e-07, "index_right": 151, "nodeid": "1393354.951424_5859007.684270", "id": "1393354.951424_5859007.684270", "name": "manhole_144_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393354.951424494385719, 5859007.684269540011883 ] } }, +{ "type": "Feature", "properties": { "_index": 151, "bedlevel": 1177.0999755859375, "branchid": "pipe_8_E124;pipe_8_E125", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_145_generated", "shape": null, "area": 0.64, "streetlevel": 1180.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1180.0999755859375, "distance_right": 4.7853676016253439e-07, "index_right": 152, "nodeid": "1393393.348943_5859039.643380", "id": "1393393.348943_5859039.643380", "name": "manhole_145_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393393.348942934535444, 5859039.643380474299192 ] } }, +{ "type": "Feature", "properties": { "_index": 152, "bedlevel": 1177.0999755859375, "branchid": "pipe_8_E125;pipe_8_E126", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_146_generated", "shape": null, "area": 0.64, "streetlevel": 1180.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1180.0999755859375, "distance_right": 5.54528936785255e-07, "index_right": 153, "nodeid": "1393431.746461_5859071.602491", "id": "1393431.746461_5859071.602491", "name": "manhole_146_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393431.746461374685168, 5859071.602491408586502 ] } }, +{ "type": "Feature", "properties": { "_index": 153, "bedlevel": 1199.5999755859375, "branchid": "pipe_8_E126;pipe_8_E127", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_147_generated", "shape": null, "area": 0.64, "streetlevel": 1202.5999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1202.5999755859375, "distance_right": 1.6846708957286895e-07, "index_right": 154, "nodeid": "1393472.672341_5859100.089054", "id": "1393472.672341_5859100.089054", "name": "manhole_147_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393472.672340910183266, 5859100.089053857140243 ] } }, +{ "type": "Feature", "properties": { "_index": 154, "bedlevel": 1199.5999755859375, "branchid": "pipe_8_E127;pipe_8_E128", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_148_generated", "shape": null, "area": 0.64, "streetlevel": 1202.5999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1202.5999755859375, "distance_right": 4.5059996646132258e-07, "index_right": 155, "nodeid": "1393507.678647_5859134.262683", "id": "1393507.678647_5859134.262683", "name": "manhole_148_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393507.678647378925234, 5859134.262682756409049 ] } }, +{ "type": "Feature", "properties": { "_index": 155, "bedlevel": 1199.5999755859375, "branchid": "pipe_8_E128;pipe_8_E129", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_149_generated", "shape": null, "area": 0.64, "streetlevel": 1202.5999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1202.5999755859375, "distance_right": 1.0640767988171364e-07, "index_right": 156, "nodeid": "1393492.637580_5859179.667013", "id": "1393492.637580_5859179.667013", "name": "manhole_149_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393492.637579936999828, 5859179.667013085447252 ] } }, +{ "type": "Feature", "properties": { "_index": 156, "bedlevel": 1229.300048828125, "branchid": "pipe_8_E129;pipe_8_E130", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_150_generated", "shape": null, "area": 0.64, "streetlevel": 1232.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1232.300048828125, "distance_right": 4.5958881840058565e-07, "index_right": 157, "nodeid": "1393472.727902_5859225.064155", "id": "1393472.727902_5859225.064155", "name": "manhole_150_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393472.727902054553851, 5859225.064155456610024 ] } }, +{ "type": "Feature", "properties": { "_index": 157, "bedlevel": 1229.300048828125, "branchid": "pipe_8_E130;pipe_8_E131", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_151_generated", "shape": null, "area": 0.64, "streetlevel": 1232.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1232.300048828125, "distance_right": 5.0290907014797333e-07, "index_right": 158, "nodeid": "1393467.563765_5859274.587596", "id": "1393467.563765_5859274.587596", "name": "manhole_151_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393467.563765458529815, 5859274.587596206925809 ] } }, +{ "type": "Feature", "properties": { "_index": 158, "bedlevel": 1229.300048828125, "branchid": "pipe_8_E131;pipe_8_E132", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_152_generated", "shape": null, "area": 0.64, "streetlevel": 1232.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1232.300048828125, "distance_right": 5.3579754438466911e-07, "index_right": 159, "nodeid": "1393473.514059_5859323.885010", "id": "1393473.514059_5859323.885010", "name": "manhole_152_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393473.51405850565061, 5859323.8850102070719 ] } }, +{ "type": "Feature", "properties": { "_index": 159, "bedlevel": 1229.300048828125, "branchid": "pipe_8_E132;pipe_8_E133", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_153_generated", "shape": null, "area": 0.64, "streetlevel": 1232.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1232.300048828125, "distance_right": 5.0577761653212759e-07, "index_right": 160, "nodeid": "1393507.773821_5859356.614803", "id": "1393507.773821_5859356.614803", "name": "manhole_153_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393507.773820924572647, 5859356.614802500233054 ] } }, +{ "type": "Feature", "properties": { "_index": 160, "bedlevel": 1211.800048828125, "branchid": "pipe_8_E133;pipe_8_E134", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_154_generated", "shape": null, "area": 0.64, "streetlevel": 1214.800048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1214.800048828125, "distance_right": 5.0605192731682803e-07, "index_right": 161, "nodeid": "1393555.824224_5859349.253152", "id": "1393555.824224_5859349.253152", "name": "manhole_154_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393555.824224345618859, 5859349.253152369521558 ] } }, +{ "type": "Feature", "properties": { "_index": 161, "bedlevel": 1211.800048828125, "branchid": "pipe_8_E134;pipe_8_E135", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_155_generated", "shape": null, "area": 0.64, "streetlevel": 1214.800048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1214.800048828125, "distance_right": 1.5717862002585569e-07, "index_right": 162, "nodeid": "1393591.003386_5859314.794960", "id": "1393591.003386_5859314.794960", "name": "manhole_155_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393591.00338595919311, 5859314.794959847815335 ] } }, +{ "type": "Feature", "properties": { "_index": 162, "bedlevel": 1188.0999755859375, "branchid": "pipe_8_E135;pipe_8_E136", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_156_generated", "shape": null, "area": 0.64, "streetlevel": 1191.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1191.0999755859375, "distance_right": 6.3842489402977489e-07, "index_right": 163, "nodeid": "1393633.153640_5859288.066565", "id": "1393633.153640_5859288.066565", "name": "manhole_156_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393633.153639519121498, 5859288.066565420478582 ] } }, +{ "type": "Feature", "properties": { "_index": 163, "bedlevel": 1188.0999755859375, "branchid": "pipe_8_E136;pipe_8_E137", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_157_generated", "shape": null, "area": 0.64, "streetlevel": 1191.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1191.0999755859375, "distance_right": 3.9680250819159843e-07, "index_right": 164, "nodeid": "1393673.123904_5859258.097713", "id": "1393673.123904_5859258.097713", "name": "manhole_157_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393673.123904188396409, 5859258.097712650895119 ] } }, +{ "type": "Feature", "properties": { "_index": 164, "bedlevel": 1141.300048828125, "branchid": "pipe_8_E137;pipe_8_E138", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_158_generated", "shape": null, "area": 0.64, "streetlevel": 1144.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1144.300048828125, "distance_right": 4.3319722731807235e-07, "index_right": 165, "nodeid": "1393720.523228_5859244.838273", "id": "1393720.523228_5859244.838273", "name": "manhole_158_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393720.523227575467899, 5859244.838272913359106 ] } }, +{ "type": "Feature", "properties": { "_index": 165, "bedlevel": 1141.300048828125, "branchid": "pipe_8_E138;pipe_8_E139", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_159_generated", "shape": null, "area": 0.64, "streetlevel": 1144.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1144.300048828125, "distance_right": 5.3625830630249993e-07, "index_right": 166, "nodeid": "1393765.710015_5859224.569285", "id": "1393765.710015_5859224.569285", "name": "manhole_159_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393765.710014625452459, 5859224.569284616038203 ] } }, +{ "type": "Feature", "properties": { "_index": 166, "bedlevel": 1141.300048828125, "branchid": "pipe_8_E139;pipe_8_E140", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_160_generated", "shape": null, "area": 0.64, "streetlevel": 1144.300048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1144.300048828125, "distance_right": 2.3237956298648694e-07, "index_right": 167, "nodeid": "1393806.409211_5859195.609256", "id": "1393806.409211_5859195.609256", "name": "manhole_160_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393806.409210936399177, 5859195.609256223775446 ] } }, +{ "type": "Feature", "properties": { "_index": 167, "bedlevel": 1109.5, "branchid": "pipe_8_E140", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_161_generated", "shape": null, "area": 0.64, "streetlevel": 1112.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1112.5, "distance_right": 5.8166784782944824e-07, "index_right": 168, "nodeid": "1393846.866743_5859166.301538", "id": "1393846.866743_5859166.301538", "name": "manhole_161_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1393846.866742686368525, 5859166.301538489758968 ] } }, +{ "type": "Feature", "properties": { "_index": 168, "bedlevel": 965.29998779296875, "branchid": "pipe_9_E1045", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_162_generated", "shape": null, "area": 0.64, "streetlevel": 968.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 968.29998779296875, "distance_right": 6.2550722664998962e-07, "index_right": 169, "nodeid": "1388521.257593_5855362.027613", "id": "1388521.257593_5855362.027613", "name": "manhole_162_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388521.257592596346512, 5855362.027613477781415 ] } }, +{ "type": "Feature", "properties": { "_index": 168, "bedlevel": 965.29998779296875, "branchid": "pipe_9_E1045;pipe_9_E1046", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_163_generated", "shape": null, "area": 0.64, "streetlevel": 968.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 968.29998779296875, "distance_right": 2.491232398801703e-07, "index_right": 170, "nodeid": "1388472.030307_5855370.543776", "id": "1388472.030307_5855370.543776", "name": "manhole_163_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388472.030306826578453, 5855370.543775821104646 ] } }, +{ "type": "Feature", "properties": { "_index": 169, "bedlevel": 965.29998779296875, "branchid": "pipe_9_E1046;pipe_9_E1047", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_164_generated", "shape": null, "area": 0.64, "streetlevel": 968.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 968.29998779296875, "distance_right": 3.4109458847801294e-07, "index_right": 171, "nodeid": "1388439.000347_5855407.802593", "id": "1388439.000347_5855407.802593", "name": "manhole_164_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388439.000347282737494, 5855407.802592809312046 ] } }, +{ "type": "Feature", "properties": { "_index": 170, "bedlevel": 961.5, "branchid": "pipe_9_E1047;pipe_9_E1048", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_165_generated", "shape": null, "area": 0.64, "streetlevel": 964.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 964.5, "distance_right": 5.0422802117576567e-07, "index_right": 172, "nodeid": "1388400.196092_5855436.014135", "id": "1388400.196092_5855436.014135", "name": "manhole_165_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388400.196091859601438, 5855436.014134516008198 ] } }, +{ "type": "Feature", "properties": { "_index": 171, "bedlevel": 961.5, "branchid": "pipe_9_E1048;pipe_9_E1049", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_166_generated", "shape": null, "area": 0.64, "streetlevel": 964.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 964.5, "distance_right": 3.5808361406298709e-07, "index_right": 173, "nodeid": "1388351.338236_5855446.634319", "id": "1388351.338236_5855446.634319", "name": "manhole_166_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388351.33823574683629, 5855446.634319253265858 ] } }, +{ "type": "Feature", "properties": { "_index": 172, "bedlevel": 978.9000244140625, "branchid": "pipe_9_E1049;pipe_9_E1050", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_167_generated", "shape": null, "area": 0.64, "streetlevel": 981.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 981.9000244140625, "distance_right": 1.5594874151965919e-07, "index_right": 174, "nodeid": "1388301.961882_5855453.847478", "id": "1388301.961882_5855453.847478", "name": "manhole_167_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388301.961881892289966, 5855453.847477887757123 ] } }, +{ "type": "Feature", "properties": { "_index": 173, "bedlevel": 978.9000244140625, "branchid": "pipe_9_E1050;pipe_9_E1051", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_168_generated", "shape": null, "area": 0.64, "streetlevel": 981.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 981.9000244140625, "distance_right": 5.2900597904754769e-07, "index_right": 175, "nodeid": "1388252.297577_5855451.260453", "id": "1388252.297577_5855451.260453", "name": "manhole_168_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388252.297577269142494, 5855451.260453455150127 ] } }, +{ "type": "Feature", "properties": { "_index": 174, "bedlevel": 970.70001220703125, "branchid": "pipe_9_E1051;pipe_9_E1052", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_169_generated", "shape": null, "area": 0.64, "streetlevel": 973.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 973.70001220703125, "distance_right": 4.3128380993449448e-07, "index_right": 176, "nodeid": "1388202.479660_5855455.508815", "id": "1388202.479660_5855455.508815", "name": "manhole_169_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388202.479659734526649, 5855455.508814659900963 ] } }, +{ "type": "Feature", "properties": { "_index": 175, "bedlevel": 958.70001220703125, "branchid": "pipe_9_E1052;pipe_9_E1053", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_170_generated", "shape": null, "area": 0.64, "streetlevel": 961.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 961.70001220703125, "distance_right": 6.5691209318399445e-07, "index_right": 177, "nodeid": "1388152.683455_5855460.015516", "id": "1388152.683455_5855460.015516", "name": "manhole_170_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388152.683455461403355, 5855460.015516467392445 ] } }, +{ "type": "Feature", "properties": { "_index": 176, "bedlevel": 958.70001220703125, "branchid": "pipe_9_E1053;pipe_9_E1054", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_171_generated", "shape": null, "area": 0.64, "streetlevel": 961.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 961.70001220703125, "distance_right": 2.006546320325504e-07, "index_right": 178, "nodeid": "1388104.622612_5855473.253734", "id": "1388104.622612_5855473.253734", "name": "manhole_171_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388104.622611842118204, 5855473.253733876161277 ] } }, +{ "type": "Feature", "properties": { "_index": 177, "bedlevel": 942.79998779296875, "branchid": "pipe_9_E1054;pipe_9_E1055", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_172_generated", "shape": null, "area": 0.64, "streetlevel": 945.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 945.79998779296875, "distance_right": 5.4215854007679352e-07, "index_right": 179, "nodeid": "1388057.005634_5855488.445189", "id": "1388057.005634_5855488.445189", "name": "manhole_172_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388057.00563437351957, 5855488.445189393125474 ] } }, +{ "type": "Feature", "properties": { "_index": 178, "bedlevel": 942.79998779296875, "branchid": "pipe_9_E1055;pipe_9_E1056", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_173_generated", "shape": null, "area": 0.64, "streetlevel": 945.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 945.79998779296875, "distance_right": 6.3206294299772168e-07, "index_right": 180, "nodeid": "1388011.292357_5855508.700276", "id": "1388011.292357_5855508.700276", "name": "manhole_173_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388011.292356542311609, 5855508.700276436284184 ] } }, +{ "type": "Feature", "properties": { "_index": 179, "bedlevel": 942.79998779296875, "branchid": "pipe_9_E1056;pipe_9_E1057", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_174_generated", "shape": null, "area": 0.64, "streetlevel": 945.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 945.79998779296875, "distance_right": 5.3811609627278667e-07, "index_right": 181, "nodeid": "1387969.221703_5855535.246165", "id": "1387969.221703_5855535.246165", "name": "manhole_174_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387969.221702651120722, 5855535.246164590120316 ] } }, +{ "type": "Feature", "properties": { "_index": 180, "bedlevel": 927.79998779296875, "branchid": "pipe_9_E1057;pipe_9_E1058", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_175_generated", "shape": null, "area": 0.64, "streetlevel": 930.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 930.79998779296875, "distance_right": 3.5287172046738913e-07, "index_right": 182, "nodeid": "1387935.863196_5855572.491062", "id": "1387935.863196_5855572.491062", "name": "manhole_175_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387935.863196024205536, 5855572.491061648353934 ] } }, +{ "type": "Feature", "properties": { "_index": 181, "bedlevel": 954.10003662109375, "branchid": "pipe_9_E1058;pipe_9_E1059", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_176_generated", "shape": null, "area": 0.64, "streetlevel": 957.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 957.10003662109375, "distance_right": 3.4948996437128579e-07, "index_right": 183, "nodeid": "1387904.610232_5855611.432585", "id": "1387904.610232_5855611.432585", "name": "manhole_176_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387904.610231971368194, 5855611.432584651745856 ] } }, +{ "type": "Feature", "properties": { "_index": 182, "bedlevel": 944.4000244140625, "branchid": "pipe_9_E1059;pipe_9_E1060", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_177_generated", "shape": null, "area": 0.64, "streetlevel": 947.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 947.4000244140625, "distance_right": 3.5311037385386945e-07, "index_right": 184, "nodeid": "1387869.335365_5855646.852918", "id": "1387869.335365_5855646.852918", "name": "manhole_177_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387869.335365027422085, 5855646.852918352000415 ] } }, +{ "type": "Feature", "properties": { "_index": 183, "bedlevel": 944.4000244140625, "branchid": "pipe_9_E1060;pipe_9_E1061", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_178_generated", "shape": null, "area": 0.64, "streetlevel": 947.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 947.4000244140625, "distance_right": 2.4558777189375542e-07, "index_right": 185, "nodeid": "1387831.783289_5855679.735664", "id": "1387831.783289_5855679.735664", "name": "manhole_178_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387831.783288773847744, 5855679.735664095729589 ] } }, +{ "type": "Feature", "properties": { "_index": 184, "bedlevel": 944.4000244140625, "branchid": "pipe_9_E1061;pipe_9_E1062", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_179_generated", "shape": null, "area": 0.64, "streetlevel": 947.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 947.4000244140625, "distance_right": 4.6498657917073899e-07, "index_right": 186, "nodeid": "1387791.509416_5855708.923280", "id": "1387791.509416_5855708.923280", "name": "manhole_179_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387791.509416193468496, 5855708.923279576934874 ] } }, +{ "type": "Feature", "properties": { "_index": 185, "bedlevel": 930.29998779296875, "branchid": "pipe_9_E1062;pipe_9_E1063", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_180_generated", "shape": null, "area": 0.64, "streetlevel": 933.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 933.29998779296875, "distance_right": 2.8252183007269098e-07, "index_right": 187, "nodeid": "1387742.459817_5855717.213658", "id": "1387742.459817_5855717.213658", "name": "manhole_180_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387742.459816947113723, 5855717.213657722808421 ] } }, +{ "type": "Feature", "properties": { "_index": 186, "bedlevel": 930.29998779296875, "branchid": "pipe_9_E1063;pipe_9_E1064", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_181_generated", "shape": null, "area": 0.64, "streetlevel": 933.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 933.29998779296875, "distance_right": 3.5363288221426471e-07, "index_right": 188, "nodeid": "1387692.500367_5855718.495404", "id": "1387692.500367_5855718.495404", "name": "manhole_181_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387692.500367184402421, 5855718.495403698645532 ] } }, +{ "type": "Feature", "properties": { "_index": 187, "bedlevel": 908.10003662109375, "branchid": "pipe_9_E1064;pipe_9_E1065", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_182_generated", "shape": null, "area": 0.64, "streetlevel": 911.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 911.10003662109375, "distance_right": 4.9034736079246513e-07, "index_right": 189, "nodeid": "1387642.500798_5855718.619679", "id": "1387642.500798_5855718.619679", "name": "manhole_182_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387642.500798417022452, 5855718.61967874225229 ] } }, +{ "type": "Feature", "properties": { "_index": 188, "bedlevel": 884.70001220703125, "branchid": "pipe_9_E1065;pipe_9_E1066", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_183_generated", "shape": null, "area": 0.64, "streetlevel": 887.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 887.70001220703125, "distance_right": 4.1118188309736872e-07, "index_right": 190, "nodeid": "1387592.501230_5855718.743954", "id": "1387592.501230_5855718.743954", "name": "manhole_183_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387592.501229649642482, 5855718.743953784927726 ] } }, +{ "type": "Feature", "properties": { "_index": 189, "bedlevel": 884.70001220703125, "branchid": "pipe_9_E1066;pipe_9_E1067", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_184_generated", "shape": null, "area": 0.64, "streetlevel": 887.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 887.70001220703125, "distance_right": 2.0872277033035481e-07, "index_right": 191, "nodeid": "1387542.501661_5855718.868229", "id": "1387542.501661_5855718.868229", "name": "manhole_184_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387542.501660882262513, 5855718.868228827603161 ] } }, +{ "type": "Feature", "properties": { "_index": 190, "bedlevel": 899.9000244140625, "branchid": "pipe_9_E1067;pipe_9_E1068", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_185_generated", "shape": null, "area": 0.64, "streetlevel": 902.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 902.9000244140625, "distance_right": 5.0275511809117188e-07, "index_right": 192, "nodeid": "1387492.651410_5855720.815255", "id": "1387492.651410_5855720.815255", "name": "manhole_185_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387492.651409652316943, 5855720.815255363471806 ] } }, +{ "type": "Feature", "properties": { "_index": 191, "bedlevel": 899.9000244140625, "branchid": "pipe_9_E1068;pipe_9_E1069", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_186_generated", "shape": null, "area": 0.64, "streetlevel": 902.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 902.9000244140625, "distance_right": 4.0143784259993902e-07, "index_right": 193, "nodeid": "1387448.867237_5855742.752517", "id": "1387448.867237_5855742.752517", "name": "manhole_186_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387448.867236748570576, 5855742.752516686916351 ] } }, +{ "type": "Feature", "properties": { "_index": 192, "bedlevel": 883.20001220703125, "branchid": "pipe_9_E1069;pipe_9_E1070", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_187_generated", "shape": null, "area": 0.64, "streetlevel": 886.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 886.20001220703125, "distance_right": 5.0383308575468889e-07, "index_right": 194, "nodeid": "1387402.432745_5855761.091834", "id": "1387402.432745_5855761.091834", "name": "manhole_187_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387402.432745414320379, 5855761.091833713464439 ] } }, +{ "type": "Feature", "properties": { "_index": 193, "bedlevel": 883.20001220703125, "branchid": "pipe_9_E1070;pipe_9_E1071", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_188_generated", "shape": null, "area": 0.64, "streetlevel": 886.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 886.20001220703125, "distance_right": 6.1468436428462281e-07, "index_right": 195, "nodeid": "1387355.687973_5855778.837216", "id": "1387355.687973_5855778.837216", "name": "manhole_188_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387355.687973388005048, 5855778.837216476909816 ] } }, +{ "type": "Feature", "properties": { "_index": 194, "bedlevel": 876.4000244140625, "branchid": "pipe_9_E1071;pipe_9_E1072", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_189_generated", "shape": null, "area": 0.64, "streetlevel": 879.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 879.4000244140625, "distance_right": 4.3414225157022518e-07, "index_right": 196, "nodeid": "1387308.943201_5855796.582599", "id": "1387308.943201_5855796.582599", "name": "manhole_189_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387308.943201361689717, 5855796.582599240355194 ] } }, +{ "type": "Feature", "properties": { "_index": 195, "bedlevel": 876.4000244140625, "branchid": "pipe_9_E1072;pipe_9_E1073", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_190_generated", "shape": null, "area": 0.64, "streetlevel": 879.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 879.4000244140625, "distance_right": 5.7963084690905175e-07, "index_right": 197, "nodeid": "1387262.861614_5855815.656713", "id": "1387262.861614_5855815.656713", "name": "manhole_190_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387262.861613623332232, 5855815.656713440082967 ] } }, +{ "type": "Feature", "properties": { "_index": 196, "bedlevel": 870.29998779296875, "branchid": "pipe_9_E1073;pipe_9_E1074", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_191_generated", "shape": null, "area": 0.64, "streetlevel": 873.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 873.29998779296875, "distance_right": 3.5155299271124064e-07, "index_right": 198, "nodeid": "1387224.059019_5855846.996292", "id": "1387224.059019_5855846.996292", "name": "manhole_191_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387224.059019178850576, 5855846.996291697025299 ] } }, +{ "type": "Feature", "properties": { "_index": 197, "bedlevel": 935.9000244140625, "branchid": "pipe_9_E1074;pipe_9_E1075", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_192_generated", "shape": null, "area": 0.64, "streetlevel": 938.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 938.9000244140625, "distance_right": 2.5239529085654171e-07, "index_right": 199, "nodeid": "1387180.719125_5855870.194652", "id": "1387180.719125_5855870.194652", "name": "manhole_192_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387180.719124856637791, 5855870.194651792757213 ] } }, +{ "type": "Feature", "properties": { "_index": 198, "bedlevel": 929.79998779296875, "branchid": "pipe_9_E1075;pipe_9_E1076", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_193_generated", "shape": null, "area": 0.64, "streetlevel": 932.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 932.79998779296875, "distance_right": 6.3377412160898568e-07, "index_right": 200, "nodeid": "1387131.003996_5855874.064550", "id": "1387131.003996_5855874.064550", "name": "manhole_193_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387131.003996425773948, 5855874.064550469629467 ] } }, +{ "type": "Feature", "properties": { "_index": 199, "bedlevel": 929.79998779296875, "branchid": "pipe_9_E1076;pipe_9_E1077", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_194_generated", "shape": null, "area": 0.64, "streetlevel": 932.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 932.79998779296875, "distance_right": 3.1656748918229132e-07, "index_right": 201, "nodeid": "1387081.098878_5855871.158614", "id": "1387081.098878_5855871.158614", "name": "manhole_194_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387081.098878284916282, 5855871.158613862469792 ] } }, +{ "type": "Feature", "properties": { "_index": 200, "bedlevel": 913.79998779296875, "branchid": "pipe_9_E1077;pipe_9_E1078", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_195_generated", "shape": null, "area": 0.64, "streetlevel": 916.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 916.79998779296875, "distance_right": 2.831909844189002e-07, "index_right": 202, "nodeid": "1387031.198060_5855868.015261", "id": "1387031.198060_5855868.015261", "name": "manhole_195_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387031.198060098802671, 5855868.015261265449226 ] } }, +{ "type": "Feature", "properties": { "_index": 201, "bedlevel": 913.79998779296875, "branchid": "pipe_9_E1078;pipe_9_E1079", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_196_generated", "shape": null, "area": 0.64, "streetlevel": 916.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 916.79998779296875, "distance_right": 3.4381447680653237e-07, "index_right": 203, "nodeid": "1386981.297242_5855864.871909", "id": "1386981.297242_5855864.871909", "name": "manhole_196_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386981.297241912456229, 5855864.871908667497337 ] } }, +{ "type": "Feature", "properties": { "_index": 202, "bedlevel": 888.79998779296875, "branchid": "pipe_9_E1079;pipe_9_E1080", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_197_generated", "shape": null, "area": 0.64, "streetlevel": 891.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 891.79998779296875, "distance_right": 4.0001585263297416e-07, "index_right": 204, "nodeid": "1386931.471473_5855860.718020", "id": "1386931.471473_5855860.718020", "name": "manhole_197_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386931.47147326474078, 5855860.718019699677825 ] } }, +{ "type": "Feature", "properties": { "_index": 203, "bedlevel": 888.79998779296875, "branchid": "pipe_9_E1080;pipe_9_E1081", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_198_generated", "shape": null, "area": 0.64, "streetlevel": 891.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 891.79998779296875, "distance_right": 2.4718676670200831e-07, "index_right": 205, "nodeid": "1386881.600664_5855857.577048", "id": "1386881.600664_5855857.577048", "name": "manhole_198_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386881.600663758814335, 5855857.577047945931554 ] } }, +{ "type": "Feature", "properties": { "_index": 204, "bedlevel": 854.10003662109375, "branchid": "pipe_9_E1081;pipe_9_E1082", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_199_generated", "shape": null, "area": 0.64, "streetlevel": 857.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 857.10003662109375, "distance_right": 2.9128081306257761e-07, "index_right": 206, "nodeid": "1386832.545594_5855864.100992", "id": "1386832.545594_5855864.100992", "name": "manhole_199_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386832.545593914575875, 5855864.100992278195918 ] } }, +{ "type": "Feature", "properties": { "_index": 205, "bedlevel": 854.10003662109375, "branchid": "pipe_9_E1082;pipe_9_E1083", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_200_generated", "shape": null, "area": 0.64, "streetlevel": 857.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 857.10003662109375, "distance_right": 5.9499673960858676e-07, "index_right": 207, "nodeid": "1386787.067649_5855884.403254", "id": "1386787.067649_5855884.403254", "name": "manhole_200_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386787.06764860637486, 5855884.403254445642233 ] } }, +{ "type": "Feature", "properties": { "_index": 206, "bedlevel": 818.29998779296875, "branchid": "pipe_9_E1083;pipe_9_E1084", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_201_generated", "shape": null, "area": 0.64, "streetlevel": 821.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 821.29998779296875, "distance_right": 4.2555588649120384e-07, "index_right": 208, "nodeid": "1386748.278359_5855915.544586", "id": "1386748.278359_5855915.544586", "name": "manhole_201_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386748.278358669718727, 5855915.544586268253624 ] } }, +{ "type": "Feature", "properties": { "_index": 207, "bedlevel": 818.29998779296875, "branchid": "pipe_9_E1084;pipe_9_E1085", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_202_generated", "shape": null, "area": 0.64, "streetlevel": 821.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 821.29998779296875, "distance_right": 2.4685857327161614e-07, "index_right": 209, "nodeid": "1386721.155420_5855957.124279", "id": "1386721.155420_5855957.124279", "name": "manhole_202_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386721.155419877264649, 5855957.124278785660863 ] } }, +{ "type": "Feature", "properties": { "_index": 208, "bedlevel": 863.0, "branchid": "pipe_9_E1085;pipe_9_E1086", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_203_generated", "shape": null, "area": 0.64, "streetlevel": 866.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 866.0, "distance_right": 2.8019898345367699e-07, "index_right": 210, "nodeid": "1386707.750366_5856004.850833", "id": "1386707.750366_5856004.850833", "name": "manhole_203_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386707.750365849817172, 5856004.850832763127983 ] } }, +{ "type": "Feature", "properties": { "_index": 209, "bedlevel": 863.0, "branchid": "pipe_9_E1086;pipe_9_E1087", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_204_generated", "shape": null, "area": 0.64, "streetlevel": 866.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 866.0, "distance_right": 1.6853915390145023e-07, "index_right": 211, "nodeid": "1386699.832476_5856054.133604", "id": "1386699.832476_5856054.133604", "name": "manhole_204_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386699.832475832896307, 5856054.133603978902102 ] } }, +{ "type": "Feature", "properties": { "_index": 210, "bedlevel": 863.0, "branchid": "pipe_9_E1087;pipe_9_E1088", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_205_generated", "shape": null, "area": 0.64, "streetlevel": 866.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 866.0, "distance_right": 2.7790305142427269e-07, "index_right": 212, "nodeid": "1386697.095561_5856103.986880", "id": "1386697.095561_5856103.986880", "name": "manhole_205_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386697.095561265014112, 5856103.986880083568394 ] } }, +{ "type": "Feature", "properties": { "_index": 211, "bedlevel": 881.79998779296875, "branchid": "pipe_9_E1088;pipe_9_E1089", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_206_generated", "shape": null, "area": 0.64, "streetlevel": 884.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 884.79998779296875, "distance_right": 9.6871259171155416e-08, "index_right": 213, "nodeid": "1386699.401159_5856153.933417", "id": "1386699.401159_5856153.933417", "name": "manhole_206_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386699.401158998254687, 5856153.933416903018951 ] } }, +{ "type": "Feature", "properties": { "_index": 212, "bedlevel": 881.79998779296875, "branchid": "pipe_9_E1089;pipe_9_E1090", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_207_generated", "shape": null, "area": 0.64, "streetlevel": 884.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 884.79998779296875, "distance_right": 3.3371584559582528e-07, "index_right": 214, "nodeid": "1386715.699191_5856201.197658", "id": "1386715.699191_5856201.197658", "name": "manhole_207_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386715.699191288091242, 5856201.197657831013203 ] } }, +{ "type": "Feature", "properties": { "_index": 213, "bedlevel": 881.79998779296875, "branchid": "pipe_9_E1090;pipe_9_E1091", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_208_generated", "shape": null, "area": 0.64, "streetlevel": 884.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 884.79998779296875, "distance_right": 3.0366052469250063e-07, "index_right": 215, "nodeid": "1386741.121204_5856244.100117", "id": "1386741.121204_5856244.100117", "name": "manhole_208_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386741.121203816728666, 5856244.100116757676005 ] } }, +{ "type": "Feature", "properties": { "_index": 214, "bedlevel": 912.9000244140625, "branchid": "pipe_9_E1091;pipe_9_E1092", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_209_generated", "shape": null, "area": 0.64, "streetlevel": 915.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 915.9000244140625, "distance_right": 5.1144535471282637e-07, "index_right": 216, "nodeid": "1386774.051379_5856281.577651", "id": "1386774.051379_5856281.577651", "name": "manhole_209_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386774.051378605188802, 5856281.577651324681938 ] } }, +{ "type": "Feature", "properties": { "_index": 215, "bedlevel": 912.9000244140625, "branchid": "pipe_9_E1092;pipe_9_E1093", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_210_generated", "shape": null, "area": 0.64, "streetlevel": 915.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 915.9000244140625, "distance_right": 3.3487951427448095e-07, "index_right": 217, "nodeid": "1386811.583792_5856314.587093", "id": "1386811.583792_5856314.587093", "name": "manhole_210_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386811.583791718119755, 5856314.587093180976808 ] } }, +{ "type": "Feature", "properties": { "_index": 216, "bedlevel": 912.9000244140625, "branchid": "pipe_9_E1093;pipe_9_E1094", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_211_generated", "shape": null, "area": 0.64, "streetlevel": 915.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 915.9000244140625, "distance_right": 5.1367843572055332e-07, "index_right": 218, "nodeid": "1386839.378956_5856356.087350", "id": "1386839.378956_5856356.087350", "name": "manhole_211_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386839.378956499742344, 5856356.087350118905306 ] } }, +{ "type": "Feature", "properties": { "_index": 217, "bedlevel": 906.9000244140625, "branchid": "pipe_9_E1094;pipe_9_E1095", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_212_generated", "shape": null, "area": 0.64, "streetlevel": 909.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 909.9000244140625, "distance_right": 5.187509063779675e-07, "index_right": 219, "nodeid": "1386855.653892_5856403.364182", "id": "1386855.653892_5856403.364182", "name": "manhole_212_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386855.653891535941511, 5856403.364181768149137 ] } }, +{ "type": "Feature", "properties": { "_index": 218, "bedlevel": 906.9000244140625, "branchid": "pipe_9_E1095;pipe_9_E1096", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_213_generated", "shape": null, "area": 0.64, "streetlevel": 909.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 909.9000244140625, "distance_right": 8.9501807475047818e-08, "index_right": 220, "nodeid": "1386875.714554_5856449.116946", "id": "1386875.714554_5856449.116946", "name": "manhole_213_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386875.714553950354457, 5856449.116945925168693 ] } }, +{ "type": "Feature", "properties": { "_index": 219, "bedlevel": 906.9000244140625, "branchid": "pipe_9_E1096;pipe_9_E1097", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_214_generated", "shape": null, "area": 0.64, "streetlevel": 909.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 909.9000244140625, "distance_right": 3.7253492332524094e-07, "index_right": 221, "nodeid": "1386912.179653_5856482.939191", "id": "1386912.179653_5856482.939191", "name": "manhole_214_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386912.179653002182022, 5856482.939191372133791 ] } }, +{ "type": "Feature", "properties": { "_index": 220, "bedlevel": 906.9000244140625, "branchid": "pipe_9_E1097;pipe_9_E1098", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_215_generated", "shape": null, "area": 0.64, "streetlevel": 909.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 909.9000244140625, "distance_right": 3.9641753867010345e-07, "index_right": 222, "nodeid": "1386944.191176_5856520.270726", "id": "1386944.191176_5856520.270726", "name": "manhole_215_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386944.191176384687424, 5856520.270725904032588 ] } }, +{ "type": "Feature", "properties": { "_index": 221, "bedlevel": 908.79998779296875, "branchid": "pipe_9_E1098;pipe_9_E1099", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_216_generated", "shape": null, "area": 0.64, "streetlevel": 911.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 911.79998779296875, "distance_right": 3.0347837754102234e-07, "index_right": 223, "nodeid": "1386964.188513_5856566.025076", "id": "1386964.188513_5856566.025076", "name": "manhole_216_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386964.188513180473819, 5856566.025075756013393 ] } }, +{ "type": "Feature", "properties": { "_index": 222, "bedlevel": 908.79998779296875, "branchid": "pipe_9_E1099;pipe_9_E1100", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_217_generated", "shape": null, "area": 0.64, "streetlevel": 911.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 911.79998779296875, "distance_right": 5.6084818431140973e-07, "index_right": 224, "nodeid": "1386998.825215_5856599.261942", "id": "1386998.825215_5856599.261942", "name": "manhole_217_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386998.825215350603685, 5856599.261941562406719 ] } }, +{ "type": "Feature", "properties": { "_index": 223, "bedlevel": 929.0, "branchid": "pipe_9_E1100;pipe_9_E1101", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_218_generated", "shape": null, "area": 0.64, "streetlevel": 932.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 932.0, "distance_right": 3.735616577513179e-07, "index_right": 225, "nodeid": "1387044.828527_5856618.849378", "id": "1387044.828527_5856618.849378", "name": "manhole_218_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387044.828526843106374, 5856618.849377661012113 ] } }, +{ "type": "Feature", "properties": { "_index": 224, "bedlevel": 929.0, "branchid": "pipe_9_E1101;pipe_9_E1102", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_219_generated", "shape": null, "area": 0.64, "streetlevel": 932.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 932.0, "distance_right": 4.1213424511758264e-07, "index_right": 226, "nodeid": "1387090.831838_5856638.436814", "id": "1387090.831838_5856638.436814", "name": "manhole_219_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387090.831838335609064, 5856638.43681376054883 ] } }, +{ "type": "Feature", "properties": { "_index": 225, "bedlevel": 946.9000244140625, "branchid": "pipe_9_E1102;pipe_9_E1103", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_220_generated", "shape": null, "area": 0.64, "streetlevel": 949.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 949.9000244140625, "distance_right": 2.2222059697487855e-07, "index_right": 227, "nodeid": "1387136.835150_5856658.024250", "id": "1387136.835150_5856658.024250", "name": "manhole_220_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387136.835149827878922, 5856658.024249859154224 ] } }, +{ "type": "Feature", "properties": { "_index": 226, "bedlevel": 921.4000244140625, "branchid": "pipe_9_E1103;pipe_9_E1104", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_221_generated", "shape": null, "area": 0.64, "streetlevel": 924.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 924.4000244140625, "distance_right": 5.4986578490835315e-07, "index_right": 228, "nodeid": "1387178.671980_5856685.128790", "id": "1387178.671980_5856685.128790", "name": "manhole_221_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387178.671980312326923, 5856685.128790453076363 ] } }, +{ "type": "Feature", "properties": { "_index": 227, "bedlevel": 921.4000244140625, "branchid": "pipe_9_E1104;pipe_9_E1105", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_222_generated", "shape": null, "area": 0.64, "streetlevel": 924.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 924.4000244140625, "distance_right": 4.3358267338019524e-07, "index_right": 229, "nodeid": "1387217.700536_5856716.320353", "id": "1387217.700536_5856716.320353", "name": "manhole_222_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387217.700535611249506, 5856716.320352808572352 ] } }, +{ "type": "Feature", "properties": { "_index": 228, "bedlevel": 937.0, "branchid": "pipe_9_E1105;pipe_9_E1106", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_223_generated", "shape": null, "area": 0.64, "streetlevel": 940.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 940.0, "distance_right": 6.2336673131863649e-07, "index_right": 230, "nodeid": "1387252.016687_5856752.649443", "id": "1387252.016687_5856752.649443", "name": "manhole_223_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387252.016686553368345, 5856752.649443434551358 ] } }, +{ "type": "Feature", "properties": { "_index": 229, "bedlevel": 937.0, "branchid": "pipe_9_E1106;pipe_9_E1107", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_224_generated", "shape": null, "area": 0.64, "streetlevel": 940.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 940.0, "distance_right": 6.6799533663431727e-07, "index_right": 231, "nodeid": "1387284.798919_5856790.190160", "id": "1387284.798919_5856790.190160", "name": "manhole_224_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387284.798919493798167, 5856790.190159549936652 ] } }, +{ "type": "Feature", "properties": { "_index": 230, "bedlevel": 891.29998779296875, "branchid": "pipe_9_E1107;pipe_9_E1108", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_225_generated", "shape": null, "area": 0.64, "streetlevel": 894.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 894.29998779296875, "distance_right": 5.7531995052493763e-07, "index_right": 232, "nodeid": "1387273.050185_5856831.931571", "id": "1387273.050185_5856831.931571", "name": "manhole_225_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387273.050185391213745, 5856831.931571422144771 ] } }, +{ "type": "Feature", "properties": { "_index": 231, "bedlevel": 888.5, "branchid": "pipe_9_E1108;pipe_9_E1109", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_226_generated", "shape": null, "area": 0.64, "streetlevel": 891.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 891.5, "distance_right": 4.1743411269132557e-07, "index_right": 233, "nodeid": "1387226.106990_5856849.145193", "id": "1387226.106990_5856849.145193", "name": "manhole_226_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387226.106990416301414, 5856849.145192969590425 ] } }, +{ "type": "Feature", "properties": { "_index": 232, "bedlevel": 888.5, "branchid": "pipe_9_E1109;pipe_9_E1110", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_227_generated", "shape": null, "area": 0.64, "streetlevel": 891.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 891.5, "distance_right": 6.552938118098987e-07, "index_right": 234, "nodeid": "1387179.163795_5856866.358815", "id": "1387179.163795_5856866.358815", "name": "manhole_227_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387179.163795441389084, 5856866.358814516104758 ] } }, +{ "type": "Feature", "properties": { "_index": 233, "bedlevel": 878.0, "branchid": "pipe_9_E1110;pipe_9_E1111", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_228_generated", "shape": null, "area": 0.64, "streetlevel": 881.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 881.0, "distance_right": 4.7110155232047406e-07, "index_right": 235, "nodeid": "1387132.220600_5856883.572436", "id": "1387132.220600_5856883.572436", "name": "manhole_228_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387132.220600466709584, 5856883.572436063550413 ] } }, +{ "type": "Feature", "properties": { "_index": 234, "bedlevel": 878.0, "branchid": "pipe_9_E1111;pipe_9_E1112", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_229_generated", "shape": null, "area": 0.64, "streetlevel": 881.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 881.0, "distance_right": 4.5292742057497235e-07, "index_right": 236, "nodeid": "1387091.513160_5856911.129931", "id": "1387091.513160_5856911.129931", "name": "manhole_229_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387091.513159692520276, 5856911.129930667579174 ] } }, +{ "type": "Feature", "properties": { "_index": 235, "bedlevel": 878.0, "branchid": "pipe_9_E1112;pipe_9_E1113", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_230_generated", "shape": null, "area": 0.64, "streetlevel": 881.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 881.0, "distance_right": 4.9429945647716522e-07, "index_right": 237, "nodeid": "1387071.007118_5856956.155595", "id": "1387071.007118_5856956.155595", "name": "manhole_230_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387071.007118243258446, 5856956.15559543017298 ] } }, +{ "type": "Feature", "properties": { "_index": 236, "bedlevel": 878.0, "branchid": "pipe_9_E1113;pipe_9_E1114", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_231_generated", "shape": null, "area": 0.64, "streetlevel": 881.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 881.0, "distance_right": 1.6586957023213196e-07, "index_right": 238, "nodeid": "1387043.749112_5856996.689189", "id": "1387043.749112_5856996.689189", "name": "manhole_231_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387043.749112035380676, 5856996.689189162105322 ] } }, +{ "type": "Feature", "properties": { "_index": 237, "bedlevel": 853.5, "branchid": "pipe_9_E1114;pipe_9_E1115", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_232_generated", "shape": null, "area": 0.64, "streetlevel": 856.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 856.5, "distance_right": 3.8972706268118116e-07, "index_right": 239, "nodeid": "1387004.639444_5857027.840532", "id": "1387004.639444_5857027.840532", "name": "manhole_232_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387004.639443967491388, 5857027.840532388538122 ] } }, +{ "type": "Feature", "properties": { "_index": 238, "bedlevel": 853.5, "branchid": "pipe_9_E1115;pipe_9_E1116", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_233_generated", "shape": null, "area": 0.64, "streetlevel": 856.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 856.5, "distance_right": 3.9655125764235331e-07, "index_right": 240, "nodeid": "1386965.529776_5857058.991876", "id": "1386965.529776_5857058.991876", "name": "manhole_233_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386965.529775899834931, 5857058.991875615902245 ] } }, +{ "type": "Feature", "properties": { "_index": 239, "bedlevel": 853.5, "branchid": "pipe_9_E1116;pipe_9_E1117", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_234_generated", "shape": null, "area": 0.64, "streetlevel": 856.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 856.5, "distance_right": 2.748546764829618e-07, "index_right": 241, "nodeid": "1386926.702535_5857090.440240", "id": "1386926.702535_5857090.440240", "name": "manhole_234_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386926.702535050921142, 5857090.440239730291069 ] } }, +{ "type": "Feature", "properties": { "_index": 240, "bedlevel": 853.5, "branchid": "pipe_9_E1117;pipe_9_E1118", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_235_generated", "shape": null, "area": 0.64, "streetlevel": 856.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 856.5, "distance_right": 1.2768484294624656e-07, "index_right": 242, "nodeid": "1386899.700980_5857131.871505", "id": "1386899.700980_5857131.871505", "name": "manhole_235_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386899.700979894958436, 5857131.871505072340369 ] } }, +{ "type": "Feature", "properties": { "_index": 241, "bedlevel": 853.5, "branchid": "pipe_9_E1118;pipe_9_E1119", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_236_generated", "shape": null, "area": 0.64, "streetlevel": 856.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 856.5, "distance_right": 1.5272838380511377e-07, "index_right": 243, "nodeid": "1386903.626394_5857181.005935", "id": "1386903.626394_5857181.005935", "name": "manhole_236_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386903.6263940166682, 5857181.005935152061284 ] } }, +{ "type": "Feature", "properties": { "_index": 242, "bedlevel": 864.29998779296875, "branchid": "pipe_9_E1119;pipe_9_E1120", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_237_generated", "shape": null, "area": 0.64, "streetlevel": 867.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 867.29998779296875, "distance_right": 3.2024778037221965e-07, "index_right": 244, "nodeid": "1386920.841402_5857227.857345", "id": "1386920.841402_5857227.857345", "name": "manhole_237_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386920.841401966754347, 5857227.85734468139708 ] } }, +{ "type": "Feature", "properties": { "_index": 243, "bedlevel": 864.29998779296875, "branchid": "pipe_9_E1120;pipe_9_E1121", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_238_generated", "shape": null, "area": 0.64, "streetlevel": 867.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 867.29998779296875, "distance_right": 5.1321625639033407e-07, "index_right": 245, "nodeid": "1386940.647245_5857273.767048", "id": "1386940.647245_5857273.767048", "name": "manhole_238_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386940.647245415020734, 5857273.767048302106559 ] } }, +{ "type": "Feature", "properties": { "_index": 244, "bedlevel": 876.0, "branchid": "pipe_9_E1121;pipe_9_E1122", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_239_generated", "shape": null, "area": 0.64, "streetlevel": 879.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 879.0, "distance_right": 1.5727567798101456e-07, "index_right": 246, "nodeid": "1386960.453089_5857319.676752", "id": "1386960.453089_5857319.676752", "name": "manhole_239_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386960.453088863519952, 5857319.676751921884716 ] } }, +{ "type": "Feature", "properties": { "_index": 245, "bedlevel": 881.5, "branchid": "pipe_9_E1122;pipe_9_E1123", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_240_generated", "shape": null, "area": 0.64, "streetlevel": 884.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 884.5, "distance_right": 5.5344274981313694e-07, "index_right": 247, "nodeid": "1386980.258932_5857365.586456", "id": "1386980.258932_5857365.586456", "name": "manhole_240_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386980.258932311786339, 5857365.586455542594194 ] } }, +{ "type": "Feature", "properties": { "_index": 246, "bedlevel": 881.5, "branchid": "pipe_9_E1123;pipe_9_E1124", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_241_generated", "shape": null, "area": 0.64, "streetlevel": 884.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 884.5, "distance_right": 2.8943349532980884e-07, "index_right": 248, "nodeid": "1387000.064776_5857411.496159", "id": "1387000.064776_5857411.496159", "name": "manhole_241_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387000.064775760285556, 5857411.496159162372351 ] } }, +{ "type": "Feature", "properties": { "_index": 247, "bedlevel": 881.5, "branchid": "pipe_9_E1124;pipe_9_E1125", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_242_generated", "shape": null, "area": 0.64, "streetlevel": 884.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 884.5, "distance_right": 1.5183128884474304e-07, "index_right": 249, "nodeid": "1387007.528902_5857459.537025", "id": "1387007.528902_5857459.537025", "name": "manhole_242_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387007.528902114601806, 5857459.537025099620223 ] } }, +{ "type": "Feature", "properties": { "_index": 248, "bedlevel": 890.20001220703125, "branchid": "pipe_9_E1125;pipe_9_E1126", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_243_generated", "shape": null, "area": 0.64, "streetlevel": 893.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 893.20001220703125, "distance_right": 3.2273594401468987e-07, "index_right": 250, "nodeid": "1386963.216765_5857476.629049", "id": "1386963.216765_5857476.629049", "name": "manhole_243_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386963.21676475298591, 5857476.629049208015203 ] } }, +{ "type": "Feature", "properties": { "_index": 249, "bedlevel": 890.70001220703125, "branchid": "pipe_9_E1126;pipe_9_E1127", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_244_generated", "shape": null, "area": 0.64, "streetlevel": 893.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 893.70001220703125, "distance_right": 4.1073674898211013e-07, "index_right": 251, "nodeid": "1386913.783934_5857484.135434", "id": "1386913.783934_5857484.135434", "name": "manhole_244_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386913.783934087026864, 5857484.135433598421514 ] } }, +{ "type": "Feature", "properties": { "_index": 250, "bedlevel": 890.70001220703125, "branchid": "pipe_9_E1127;pipe_9_E1128", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_245_generated", "shape": null, "area": 0.64, "streetlevel": 893.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 893.70001220703125, "distance_right": 3.5443776076362833e-07, "index_right": 252, "nodeid": "1386870.539328_5857507.055612", "id": "1386870.539328_5857507.055612", "name": "manhole_245_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386870.539328352315351, 5857507.055611960589886 ] } }, +{ "type": "Feature", "properties": { "_index": 251, "bedlevel": 886.70001220703125, "branchid": "pipe_9_E1128;pipe_9_E1129", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_246_generated", "shape": null, "area": 0.64, "streetlevel": 889.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 889.70001220703125, "distance_right": 2.5526777072037769e-07, "index_right": 253, "nodeid": "1386832.820274_5857539.877027", "id": "1386832.820274_5857539.877027", "name": "manhole_246_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386832.820274166297168, 5857539.877026806585491 ] } }, +{ "type": "Feature", "properties": { "_index": 252, "bedlevel": 886.70001220703125, "branchid": "pipe_9_E1129;pipe_9_E1130", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_247_generated", "shape": null, "area": 0.64, "streetlevel": 889.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 889.70001220703125, "distance_right": 1.5366822481155396e-07, "index_right": 254, "nodeid": "1386795.101532_5857572.698800", "id": "1386795.101532_5857572.698800", "name": "manhole_247_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386795.101531907683238, 5857572.698800123296678 ] } }, +{ "type": "Feature", "properties": { "_index": 253, "bedlevel": 869.4000244140625, "branchid": "pipe_9_E1130;pipe_9_E1131", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_248_generated", "shape": null, "area": 0.64, "streetlevel": 872.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 872.4000244140625, "distance_right": 3.7786232856336934e-07, "index_right": 255, "nodeid": "1386758.257366_5857606.496797", "id": "1386758.257366_5857606.496797", "name": "manhole_248_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386758.257366374600679, 5857606.496797049418092 ] } }, +{ "type": "Feature", "properties": { "_index": 254, "bedlevel": 869.4000244140625, "branchid": "pipe_9_E1131;pipe_9_E1132", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_249_generated", "shape": null, "area": 0.64, "streetlevel": 872.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 872.4000244140625, "distance_right": 3.2795260285698398e-07, "index_right": 256, "nodeid": "1386721.502390_5857640.394349", "id": "1386721.502390_5857640.394349", "name": "manhole_249_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386721.502390186069533, 5857640.394349270500243 ] } }, +{ "type": "Feature", "properties": { "_index": 255, "bedlevel": 869.4000244140625, "branchid": "pipe_9_E1132;pipe_9_E1133", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_250_generated", "shape": null, "area": 0.64, "streetlevel": 872.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 872.4000244140625, "distance_right": 4.6900674597777131e-07, "index_right": 257, "nodeid": "1386691.639095_5857680.292891", "id": "1386691.639095_5857680.292891", "name": "manhole_250_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386691.639095245627686, 5857680.292891399934888 ] } }, +{ "type": "Feature", "properties": { "_index": 256, "bedlevel": 857.70001220703125, "branchid": "pipe_9_E1133;pipe_9_E1134", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_251_generated", "shape": null, "area": 0.64, "streetlevel": 860.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 860.70001220703125, "distance_right": 3.3192243792747955e-07, "index_right": 258, "nodeid": "1386663.127201_5857721.366520", "id": "1386663.127201_5857721.366520", "name": "manhole_251_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386663.127201205352321, 5857721.366519738920033 ] } }, +{ "type": "Feature", "properties": { "_index": 257, "bedlevel": 861.10003662109375, "branchid": "pipe_9_E1134;pipe_9_E1135", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_252_generated", "shape": null, "area": 0.64, "streetlevel": 864.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 864.10003662109375, "distance_right": 5.2146766921896017e-07, "index_right": 259, "nodeid": "1386634.707845_5857762.504246", "id": "1386634.707845_5857762.504246", "name": "manhole_252_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386634.70784462057054, 5857762.504245642572641 ] } }, +{ "type": "Feature", "properties": { "_index": 258, "bedlevel": 861.10003662109375, "branchid": "pipe_9_E1135;pipe_9_E1136", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_253_generated", "shape": null, "area": 0.64, "streetlevel": 864.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 864.10003662109375, "distance_right": 4.5498759751961357e-07, "index_right": 260, "nodeid": "1386606.288488_5857803.641972", "id": "1386606.288488_5857803.641972", "name": "manhole_253_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386606.28848803602159, 5857803.64197154622525 ] } }, +{ "type": "Feature", "properties": { "_index": 259, "bedlevel": 861.10003662109375, "branchid": "pipe_9_E1136;pipe_9_E1137", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_254_generated", "shape": null, "area": 0.64, "streetlevel": 864.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 864.10003662109375, "distance_right": 2.5699989460409016e-07, "index_right": 261, "nodeid": "1386577.851668_5857844.766918", "id": "1386577.851668_5857844.766918", "name": "manhole_254_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386577.851668093586341, 5857844.766917760483921 ] } }, +{ "type": "Feature", "properties": { "_index": 260, "bedlevel": 833.10003662109375, "branchid": "pipe_9_E1137;pipe_9_E1138", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_255_generated", "shape": null, "area": 0.64, "streetlevel": 836.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 836.10003662109375, "distance_right": 4.6245863146990199e-07, "index_right": 262, "nodeid": "1386559.479124_5857890.340474", "id": "1386559.479124_5857890.340474", "name": "manhole_255_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386559.479123871540651, 5857890.340473555959761 ] } }, +{ "type": "Feature", "properties": { "_index": 261, "bedlevel": 833.10003662109375, "branchid": "pipe_9_E1138;pipe_9_E1139", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_256_generated", "shape": null, "area": 0.64, "streetlevel": 836.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 836.10003662109375, "distance_right": 5.021981574989325e-07, "index_right": 263, "nodeid": "1386576.858566_5857935.633446", "id": "1386576.858566_5857935.633446", "name": "manhole_256_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386576.858566463226452, 5857935.633445805869997 ] } }, +{ "type": "Feature", "properties": { "_index": 262, "bedlevel": 851.9000244140625, "branchid": "pipe_9_E1139;pipe_9_E1140", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_257_generated", "shape": null, "area": 0.64, "streetlevel": 854.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 854.9000244140625, "distance_right": 4.9781434926194598e-07, "index_right": 264, "nodeid": "1386619.073707_5857961.189545", "id": "1386619.073707_5857961.189545", "name": "manhole_257_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386619.073707325849682, 5857961.189545376226306 ] } }, +{ "type": "Feature", "properties": { "_index": 263, "bedlevel": 851.9000244140625, "branchid": "pipe_9_E1140;pipe_9_E1141", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_258_generated", "shape": null, "area": 0.64, "streetlevel": 854.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 854.9000244140625, "distance_right": 5.8796597557960585e-07, "index_right": 265, "nodeid": "1386664.860783_5857981.277063", "id": "1386664.860783_5857981.277063", "name": "manhole_258_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386664.860782509436831, 5857981.27706332411617 ] } }, +{ "type": "Feature", "properties": { "_index": 264, "bedlevel": 868.60003662109375, "branchid": "pipe_9_E1141;pipe_9_E1142", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_259_generated", "shape": null, "area": 0.64, "streetlevel": 871.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 871.60003662109375, "distance_right": 2.1920383756110676e-07, "index_right": 266, "nodeid": "1386710.721603_5858001.195835", "id": "1386710.721603_5858001.195835", "name": "manhole_259_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386710.721602912992239, 5858001.195835201069713 ] } }, +{ "type": "Feature", "properties": { "_index": 265, "bedlevel": 862.10003662109375, "branchid": "pipe_9_E1142;pipe_9_E1143", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_260_generated", "shape": null, "area": 0.64, "streetlevel": 865.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 865.10003662109375, "distance_right": 3.2639501446625323e-07, "index_right": 267, "nodeid": "1386756.582423_5858021.114607", "id": "1386756.582423_5858021.114607", "name": "manhole_260_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386756.582423316547647, 5858021.114607078954577 ] } }, +{ "type": "Feature", "properties": { "_index": 266, "bedlevel": 861.70001220703125, "branchid": "pipe_9_E1143;pipe_9_E1144", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_261_generated", "shape": null, "area": 0.64, "streetlevel": 864.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 864.70001220703125, "distance_right": 2.8312244562798407e-07, "index_right": 268, "nodeid": "1386802.443244_5858041.033379", "id": "1386802.443244_5858041.033379", "name": "manhole_261_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386802.443243720103055, 5858041.033378956839442 ] } }, +{ "type": "Feature", "properties": { "_index": 267, "bedlevel": 861.70001220703125, "branchid": "pipe_9_E1144;pipe_9_E1145", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_262_generated", "shape": null, "area": 0.64, "streetlevel": 864.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 864.70001220703125, "distance_right": 2.0605511963367462e-07, "index_right": 269, "nodeid": "1386848.304064_5858060.952151", "id": "1386848.304064_5858060.952151", "name": "manhole_262_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386848.304064123658463, 5858060.952150834724307 ] } }, +{ "type": "Feature", "properties": { "_index": 268, "bedlevel": 856.20001220703125, "branchid": "pipe_9_E1145;pipe_9_E1146", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_263_generated", "shape": null, "area": 0.64, "streetlevel": 859.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 859.20001220703125, "distance_right": 2.7649861880441913e-07, "index_right": 270, "nodeid": "1386892.843548_5858083.471455", "id": "1386892.843548_5858083.471455", "name": "manhole_263_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386892.843548113014549, 5858083.471454747952521 ] } }, +{ "type": "Feature", "properties": { "_index": 269, "bedlevel": 856.20001220703125, "branchid": "pipe_9_E1146;pipe_9_E1147", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_264_generated", "shape": null, "area": 0.64, "streetlevel": 859.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 859.20001220703125, "distance_right": 3.0590260754863043e-07, "index_right": 271, "nodeid": "1386931.443848_5858115.251782", "id": "1386931.443848_5858115.251782", "name": "manhole_264_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386931.443847785238177, 5858115.251781782135367 ] } }, +{ "type": "Feature", "properties": { "_index": 270, "bedlevel": 850.60003662109375, "branchid": "pipe_9_E1147;pipe_9_E1148", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_265_generated", "shape": null, "area": 0.64, "streetlevel": 853.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 853.60003662109375, "distance_right": 4.9236673697818464e-07, "index_right": 272, "nodeid": "1386970.044147_5858147.032109", "id": "1386970.044147_5858147.032109", "name": "manhole_265_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386970.044147457228974, 5858147.032108817249537 ] } }, +{ "type": "Feature", "properties": { "_index": 271, "bedlevel": 850.60003662109375, "branchid": "pipe_9_E1148;pipe_9_E1149", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_266_generated", "shape": null, "area": 0.64, "streetlevel": 853.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 853.60003662109375, "distance_right": 1.9738985949682692e-07, "index_right": 273, "nodeid": "1387008.644447_5858178.812436", "id": "1387008.644447_5858178.812436", "name": "manhole_266_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387008.644447129452601, 5858178.812435851432383 ] } }, +{ "type": "Feature", "properties": { "_index": 272, "bedlevel": 839.4000244140625, "branchid": "pipe_9_E1149;pipe_9_E1150", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_267_generated", "shape": null, "area": 0.64, "streetlevel": 842.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 842.4000244140625, "distance_right": 2.2880903617256829e-07, "index_right": 274, "nodeid": "1387047.244747_5858210.592763", "id": "1387047.244747_5858210.592763", "name": "manhole_267_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387047.244746801443398, 5858210.592762886546552 ] } }, +{ "type": "Feature", "properties": { "_index": 273, "bedlevel": 839.4000244140625, "branchid": "pipe_9_E1150;pipe_9_E1151", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_268_generated", "shape": null, "area": 0.64, "streetlevel": 842.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 842.4000244140625, "distance_right": 4.8014827367443299e-07, "index_right": 275, "nodeid": "1387085.845046_5858242.373090", "id": "1387085.845046_5858242.373090", "name": "manhole_268_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387085.845046473667026, 5858242.373089920729399 ] } }, +{ "type": "Feature", "properties": { "_index": 274, "bedlevel": 839.4000244140625, "branchid": "pipe_9_E1151;pipe_9_E1152", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_269_generated", "shape": null, "area": 0.64, "streetlevel": 842.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 842.4000244140625, "distance_right": 1.5218292481899163e-07, "index_right": 276, "nodeid": "1387124.445346_5858274.153417", "id": "1387124.445346_5858274.153417", "name": "manhole_269_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387124.445346145657822, 5858274.153416955843568 ] } }, +{ "type": "Feature", "properties": { "_index": 275, "bedlevel": 824.60003662109375, "branchid": "pipe_9_E1152;pipe_9_E1153", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_270_generated", "shape": null, "area": 0.64, "streetlevel": 827.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 827.60003662109375, "distance_right": 1.8236154538895495e-07, "index_right": 277, "nodeid": "1387163.045646_5858305.933744", "id": "1387163.045646_5858305.933744", "name": "manhole_270_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387163.04564581788145, 5858305.933743990026414 ] } }, +{ "type": "Feature", "properties": { "_index": 276, "bedlevel": 824.60003662109375, "branchid": "pipe_9_E1153;pipe_9_E1154", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_271_generated", "shape": null, "area": 0.64, "streetlevel": 827.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 827.60003662109375, "distance_right": 1.9809660257622753e-07, "index_right": 278, "nodeid": "1387201.829349_5858337.489215", "id": "1387201.829349_5858337.489215", "name": "manhole_271_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387201.829349192325026, 5858337.489215047098696 ] } }, +{ "type": "Feature", "properties": { "_index": 277, "bedlevel": 834.60003662109375, "branchid": "pipe_9_E1154;pipe_9_E1155", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_272_generated", "shape": null, "area": 0.64, "streetlevel": 837.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 837.60003662109375, "distance_right": 3.1535765417261081e-07, "index_right": 279, "nodeid": "1387246.200623_5858359.687652", "id": "1387246.200623_5858359.687652", "name": "manhole_272_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387246.200623227981851, 5858359.687651782296598 ] } }, +{ "type": "Feature", "properties": { "_index": 278, "bedlevel": 834.60003662109375, "branchid": "pipe_9_E1155;pipe_9_E1156", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_273_generated", "shape": null, "area": 0.64, "streetlevel": 837.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 837.60003662109375, "distance_right": 3.7290166354514342e-07, "index_right": 280, "nodeid": "1387293.201938_5858376.741939", "id": "1387293.201938_5858376.741939", "name": "manhole_273_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387293.201938283629715, 5858376.741938757710159 ] } }, +{ "type": "Feature", "properties": { "_index": 279, "bedlevel": 840.79998779296875, "branchid": "pipe_9_E1156;pipe_9_E1157", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_274_generated", "shape": null, "area": 0.64, "streetlevel": 843.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 843.79998779296875, "distance_right": 4.6077813805798978e-07, "index_right": 281, "nodeid": "1387334.200528_5858401.732468", "id": "1387334.200528_5858401.732468", "name": "manhole_274_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387334.200528149493039, 5858401.732468435540795 ] } }, +{ "type": "Feature", "properties": { "_index": 280, "bedlevel": 819.60003662109375, "branchid": "pipe_9_E1157;pipe_9_E1158", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_275_generated", "shape": null, "area": 0.64, "streetlevel": 822.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 822.60003662109375, "distance_right": 8.5382524018633532e-08, "index_right": 282, "nodeid": "1387307.843875_5858437.110806", "id": "1387307.843875_5858437.110806", "name": "manhole_275_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387307.843875054037198, 5858437.110805934295058 ] } }, +{ "type": "Feature", "properties": { "_index": 281, "bedlevel": 819.60003662109375, "branchid": "pipe_9_E1158;pipe_9_E1159", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_276_generated", "shape": null, "area": 0.64, "streetlevel": 822.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 822.60003662109375, "distance_right": 4.2349814041677047e-07, "index_right": 283, "nodeid": "1387260.279569_5858425.045736", "id": "1387260.279569_5858425.045736", "name": "manhole_276_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387260.279569417703897, 5858425.045736069791019 ] } }, +{ "type": "Feature", "properties": { "_index": 282, "bedlevel": 824.60003662109375, "branchid": "pipe_9_E1159;pipe_9_E1160", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_277_generated", "shape": null, "area": 0.64, "streetlevel": 827.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 827.60003662109375, "distance_right": 1.9456452023223653e-07, "index_right": 284, "nodeid": "1387211.448235_5858414.300555", "id": "1387211.448235_5858414.300555", "name": "manhole_277_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387211.448235018178821, 5858414.300554806366563 ] } }, +{ "type": "Feature", "properties": { "_index": 283, "bedlevel": 824.60003662109375, "branchid": "pipe_9_E1160;pipe_9_E1161", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_278_generated", "shape": null, "area": 0.64, "streetlevel": 827.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 827.60003662109375, "distance_right": 5.9301123926818533e-07, "index_right": 285, "nodeid": "1387162.612192_5858403.576135", "id": "1387162.612192_5858403.576135", "name": "manhole_278_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387162.612191663123667, 5858403.576134512200952 ] } }, +{ "type": "Feature", "properties": { "_index": 284, "bedlevel": 819.29998779296875, "branchid": "pipe_9_E1161;pipe_9_E1162", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_279_generated", "shape": null, "area": 0.64, "streetlevel": 822.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 822.29998779296875, "distance_right": 4.6731291105077109e-07, "index_right": 286, "nodeid": "1387113.700151_5858393.210483", "id": "1387113.700151_5858393.210483", "name": "manhole_279_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387113.700150535441935, 5858393.210482948459685 ] } }, +{ "type": "Feature", "properties": { "_index": 285, "bedlevel": 819.29998779296875, "branchid": "pipe_9_E1162;pipe_9_E1163", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_280_generated", "shape": null, "area": 0.64, "streetlevel": 822.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 822.29998779296875, "distance_right": 4.0153296690850306e-07, "index_right": 287, "nodeid": "1387064.993171_5858381.975642", "id": "1387064.993171_5858381.975642", "name": "manhole_280_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387064.993171223672107, 5858381.975642333738506 ] } }, +{ "type": "Feature", "properties": { "_index": 286, "bedlevel": 824.79998779296875, "branchid": "pipe_9_E1163;pipe_9_E1164", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_281_generated", "shape": null, "area": 0.64, "streetlevel": 827.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 827.79998779296875, "distance_right": 4.0215514115362912e-07, "index_right": 288, "nodeid": "1387015.796387_5858376.342008", "id": "1387015.796387_5858376.342008", "name": "manhole_281_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387015.796386598376557, 5858376.342007979750633 ] } }, +{ "type": "Feature", "properties": { "_index": 287, "bedlevel": 824.79998779296875, "branchid": "pipe_9_E1164;pipe_9_E1165", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_282_generated", "shape": null, "area": 0.64, "streetlevel": 827.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 827.79998779296875, "distance_right": 4.3499145420040634e-07, "index_right": 289, "nodeid": "1386966.208506_5858382.746259", "id": "1386966.208506_5858382.746259", "name": "manhole_282_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386966.208506174152717, 5858382.746259398758411 ] } }, +{ "type": "Feature", "properties": { "_index": 288, "bedlevel": 830.9000244140625, "branchid": "pipe_9_E1165;pipe_9_E1166", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_283_generated", "shape": null, "area": 0.64, "streetlevel": 833.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 833.9000244140625, "distance_right": 4.8373153624010088e-07, "index_right": 290, "nodeid": "1386916.676812_5858389.559526", "id": "1386916.676812_5858389.559526", "name": "manhole_283_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386916.676812386140227, 5858389.559525708667934 ] } }, +{ "type": "Feature", "properties": { "_index": 289, "bedlevel": 830.9000244140625, "branchid": "pipe_9_E1166;pipe_9_E1167", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_284_generated", "shape": null, "area": 0.64, "streetlevel": 833.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 833.9000244140625, "distance_right": 4.8908646858358934e-07, "index_right": 291, "nodeid": "1386867.198861_5858396.764011", "id": "1386867.198861_5858396.764011", "name": "manhole_284_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386867.198860567295924, 5858396.764010772109032 ] } }, +{ "type": "Feature", "properties": { "_index": 290, "bedlevel": 830.20001220703125, "branchid": "pipe_9_E1167;pipe_9_E1168", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_285_generated", "shape": null, "area": 0.64, "streetlevel": 833.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 833.20001220703125, "distance_right": 1.7726120334507922e-07, "index_right": 292, "nodeid": "1386820.816385_5858411.854354", "id": "1386820.816385_5858411.854354", "name": "manhole_285_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386820.816385147860274, 5858411.854353901930153 ] } }, +{ "type": "Feature", "properties": { "_index": 291, "bedlevel": 806.60003662109375, "branchid": "pipe_9_E1168;pipe_9_E1169", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_286_generated", "shape": null, "area": 0.64, "streetlevel": 809.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 809.60003662109375, "distance_right": 3.1442733213135406e-07, "index_right": 293, "nodeid": "1386841.361235_5858445.514384", "id": "1386841.361235_5858445.514384", "name": "manhole_286_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386841.361234750133008, 5858445.514383808709681 ] } }, +{ "type": "Feature", "properties": { "_index": 292, "bedlevel": 806.79998779296875, "branchid": "pipe_9_E1169;pipe_9_E1170", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_287_generated", "shape": null, "area": 0.64, "streetlevel": 809.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 809.79998779296875, "distance_right": 1.0385212439389687e-07, "index_right": 294, "nodeid": "1386890.796275_5858452.915635", "id": "1386890.796275_5858452.915635", "name": "manhole_287_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386890.796275103231892, 5858452.915634987875819 ] } }, +{ "type": "Feature", "properties": { "_index": 293, "bedlevel": 806.79998779296875, "branchid": "pipe_9_E1170;pipe_9_E1171", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_288_generated", "shape": null, "area": 0.64, "streetlevel": 809.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 809.79998779296875, "distance_right": 3.6124182714980252e-07, "index_right": 295, "nodeid": "1386940.277141_5858460.100081", "id": "1386940.277141_5858460.100081", "name": "manhole_288_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386940.277140651131049, 5858460.100081093609333 ] } }, +{ "type": "Feature", "properties": { "_index": 294, "bedlevel": 802.4000244140625, "branchid": "pipe_9_E1171;pipe_9_E1172", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_289_generated", "shape": null, "area": 0.64, "streetlevel": 805.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 805.4000244140625, "distance_right": 5.0630815568272578e-07, "index_right": 296, "nodeid": "1386989.847998_5858466.483407", "id": "1386989.847998_5858466.483407", "name": "manhole_289_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386989.847997799050063, 5858466.483407464809716 ] } }, +{ "type": "Feature", "properties": { "_index": 295, "bedlevel": 802.4000244140625, "branchid": "pipe_9_E1172;pipe_9_E1173", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_290_generated", "shape": null, "area": 0.64, "streetlevel": 805.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 805.4000244140625, "distance_right": 5.2372736805822677e-07, "index_right": 297, "nodeid": "1387039.689649_5858470.456085", "id": "1387039.689649_5858470.456085", "name": "manhole_290_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387039.689648573985323, 5858470.45608530472964 ] } }, +{ "type": "Feature", "properties": { "_index": 296, "bedlevel": 801.60003662109375, "branchid": "pipe_9_E1173;pipe_9_E1174", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_291_generated", "shape": null, "area": 0.64, "streetlevel": 804.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 804.60003662109375, "distance_right": 1.5993024886383644e-07, "index_right": 298, "nodeid": "1387088.843806_5858479.424947", "id": "1387088.843806_5858479.424947", "name": "manhole_291_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387088.843806148739532, 5858479.424946941435337 ] } }, +{ "type": "Feature", "properties": { "_index": 297, "bedlevel": 806.9000244140625, "branchid": "pipe_9_E1174;pipe_9_E1175", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_292_generated", "shape": null, "area": 0.64, "streetlevel": 809.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 809.9000244140625, "distance_right": 3.7517997879668708e-07, "index_right": 299, "nodeid": "1387137.906045_5858489.061807", "id": "1387137.906045_5858489.061807", "name": "manhole_292_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387137.90604472765699, 5858489.061806742101908 ] } }, +{ "type": "Feature", "properties": { "_index": 298, "bedlevel": 806.9000244140625, "branchid": "pipe_9_E1175;pipe_9_E1176", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_293_generated", "shape": null, "area": 0.64, "streetlevel": 809.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 809.9000244140625, "distance_right": 3.6405332731419796e-07, "index_right": 300, "nodeid": "1387186.336530_5858500.879681", "id": "1387186.336530_5858500.879681", "name": "manhole_293_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387186.336529975291342, 5858500.87968063633889 ] } }, +{ "type": "Feature", "properties": { "_index": 299, "bedlevel": 819.60003662109375, "branchid": "pipe_9_E1176;pipe_9_E1177", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_294_generated", "shape": null, "area": 0.64, "streetlevel": 822.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 822.60003662109375, "distance_right": 4.7023029237319848e-07, "index_right": 301, "nodeid": "1387231.661051_5858521.423060", "id": "1387231.661051_5858521.423060", "name": "manhole_294_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387231.661050535272807, 5858521.423059928230941 ] } }, +{ "type": "Feature", "properties": { "_index": 300, "bedlevel": 784.70001220703125, "branchid": "pipe_9_E1177;pipe_9_E1178", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_295_generated", "shape": null, "area": 0.64, "streetlevel": 787.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 787.70001220703125, "distance_right": 3.9755428442383632e-07, "index_right": 302, "nodeid": "1387268.120025_5858555.035049", "id": "1387268.120025_5858555.035049", "name": "manhole_295_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387268.120024613803253, 5858555.03504909388721 ] } }, +{ "type": "Feature", "properties": { "_index": 301, "bedlevel": 784.70001220703125, "branchid": "pipe_9_E1178;pipe_9_E1179", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_296_generated", "shape": null, "area": 0.64, "streetlevel": 787.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 787.70001220703125, "distance_right": 5.1789956777309593e-07, "index_right": 303, "nodeid": "1387300.917169_5858592.775208", "id": "1387300.917169_5858592.775208", "name": "manhole_296_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387300.917169471969828, 5858592.775208213366568 ] } }, +{ "type": "Feature", "properties": { "_index": 302, "bedlevel": 794.10003662109375, "branchid": "pipe_9_E1179;pipe_9_E1180", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_297_generated", "shape": null, "area": 0.64, "streetlevel": 797.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 797.10003662109375, "distance_right": 3.1601800580138037e-07, "index_right": 304, "nodeid": "1387340.521647_5858622.315198", "id": "1387340.521647_5858622.315198", "name": "manhole_297_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387340.521646688459441, 5858622.315198052674532 ] } }, +{ "type": "Feature", "properties": { "_index": 303, "bedlevel": 794.10003662109375, "branchid": "pipe_9_E1180;pipe_9_E1181", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_298_generated", "shape": null, "area": 0.64, "streetlevel": 797.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 797.10003662109375, "distance_right": 5.0820743069320088e-07, "index_right": 305, "nodeid": "1387387.476920_5858639.495844", "id": "1387387.476920_5858639.495844", "name": "manhole_298_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387387.476920192595571, 5858639.495844470337033 ] } }, +{ "type": "Feature", "properties": { "_index": 304, "bedlevel": 803.10003662109375, "branchid": "pipe_9_E1181;pipe_9_E1182", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_299_generated", "shape": null, "area": 0.64, "streetlevel": 806.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 806.10003662109375, "distance_right": 6.6801801863117119e-07, "index_right": 306, "nodeid": "1387436.116963_5858650.828613", "id": "1387436.116963_5858650.828613", "name": "manhole_299_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387436.116963447071612, 5858650.82861250359565 ] } }, +{ "type": "Feature", "properties": { "_index": 305, "bedlevel": 803.10003662109375, "branchid": "pipe_9_E1182;pipe_9_E1183", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_300_generated", "shape": null, "area": 0.64, "streetlevel": 806.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 806.10003662109375, "distance_right": 5.6479670540947805e-07, "index_right": 307, "nodeid": "1387485.194104_5858660.261458", "id": "1387485.194104_5858660.261458", "name": "manhole_300_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387485.194103535497561, 5858660.261457678861916 ] } }, +{ "type": "Feature", "properties": { "_index": 306, "bedlevel": 804.70001220703125, "branchid": "pipe_9_E1183;pipe_9_E1184", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_301_generated", "shape": null, "area": 0.64, "streetlevel": 807.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.70001220703125, "distance_right": 4.4892163287133709e-07, "index_right": 308, "nodeid": "1387533.804190_5858671.493854", "id": "1387533.804190_5858671.493854", "name": "manhole_301_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387533.804190448950976, 5858671.493853995576501 ] } }, +{ "type": "Feature", "properties": { "_index": 307, "bedlevel": 769.20001220703125, "branchid": "pipe_9_E1184;pipe_9_E1185", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_302_generated", "shape": null, "area": 0.64, "streetlevel": 772.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 772.20001220703125, "distance_right": 3.8060938621151436e-07, "index_right": 309, "nodeid": "1387580.296834_5858689.619015", "id": "1387580.296834_5858689.619015", "name": "manhole_302_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387580.2968336828053, 5858689.619015210308135 ] } }, +{ "type": "Feature", "properties": { "_index": 308, "bedlevel": 775.79998779296875, "branchid": "pipe_9_E1185;pipe_9_E1186", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_303_generated", "shape": null, "area": 0.64, "streetlevel": 778.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 778.79998779296875, "distance_right": 1.987741082007922e-07, "index_right": 310, "nodeid": "1387628.455277_5858703.062848", "id": "1387628.455277_5858703.062848", "name": "manhole_303_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387628.455277157016098, 5858703.062848121859133 ] } }, +{ "type": "Feature", "properties": { "_index": 309, "bedlevel": 775.79998779296875, "branchid": "pipe_9_E1186;pipe_9_E1187", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_304_generated", "shape": null, "area": 0.64, "streetlevel": 778.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 778.79998779296875, "distance_right": 1.0050088277659534e-07, "index_right": 311, "nodeid": "1387677.211432_5858713.786249", "id": "1387677.211432_5858713.786249", "name": "manhole_304_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387677.211432087467983, 5858713.7862489502877 ] } }, +{ "type": "Feature", "properties": { "_index": 310, "bedlevel": 783.70001220703125, "branchid": "pipe_9_E1187;pipe_9_E1188", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_305_generated", "shape": null, "area": 0.64, "streetlevel": 786.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 786.70001220703125, "distance_right": 2.8897612857941058e-07, "index_right": 312, "nodeid": "1387726.995392_5858712.747127", "id": "1387726.995392_5858712.747127", "name": "manhole_305_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387726.995392211945727, 5858712.747126803733408 ] } }, +{ "type": "Feature", "properties": { "_index": 311, "bedlevel": 783.70001220703125, "branchid": "pipe_9_E1188;pipe_9_E1189", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_306_generated", "shape": null, "area": 0.64, "streetlevel": 786.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 786.70001220703125, "distance_right": 4.773026491265167e-07, "index_right": 313, "nodeid": "1387773.343349_5858725.014478", "id": "1387773.343349_5858725.014478", "name": "manhole_306_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387773.343349169706926, 5858725.014477553777397 ] } }, +{ "type": "Feature", "properties": { "_index": 312, "bedlevel": 794.70001220703125, "branchid": "pipe_9_E1189;pipe_9_E1190", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_307_generated", "shape": null, "area": 0.64, "streetlevel": 797.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 797.70001220703125, "distance_right": 5.0487611162469514e-07, "index_right": 314, "nodeid": "1387806.363672_5858762.310494", "id": "1387806.363672_5858762.310494", "name": "manhole_307_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387806.363672176143155, 5858762.310494473204017 ] } }, +{ "type": "Feature", "properties": { "_index": 313, "bedlevel": 794.70001220703125, "branchid": "pipe_9_E1190;pipe_9_E1191", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_308_generated", "shape": null, "area": 0.64, "streetlevel": 797.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 797.70001220703125, "distance_right": 3.7741157887003312e-07, "index_right": 315, "nodeid": "1387799.717028_5858810.149600", "id": "1387799.717028_5858810.149600", "name": "manhole_308_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387799.717027904232964, 5858810.149600365199149 ] } }, +{ "type": "Feature", "properties": { "_index": 314, "bedlevel": 749.70001220703125, "branchid": "pipe_9_E1191;pipe_9_E1192", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_309_generated", "shape": null, "area": 0.64, "streetlevel": 752.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 752.70001220703125, "distance_right": 3.5034815396929229e-07, "index_right": 316, "nodeid": "1387771.971140_5858850.861094", "id": "1387771.971140_5858850.861094", "name": "manhole_309_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387771.971139753237367, 5858850.86109375115484 ] } }, +{ "type": "Feature", "properties": { "_index": 315, "bedlevel": 749.70001220703125, "branchid": "pipe_9_E1192;pipe_9_E1193", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_310_generated", "shape": null, "area": 0.64, "streetlevel": 752.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 752.70001220703125, "distance_right": 3.0946021768837125e-07, "index_right": 317, "nodeid": "1387723.076751_5858854.679318", "id": "1387723.076751_5858854.679318", "name": "manhole_310_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387723.07675126590766, 5858854.679317841306329 ] } }, +{ "type": "Feature", "properties": { "_index": 316, "bedlevel": 749.70001220703125, "branchid": "pipe_9_E1193;pipe_9_E1194", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_311_generated", "shape": null, "area": 0.64, "streetlevel": 752.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 752.70001220703125, "distance_right": 2.4466856167220514e-07, "index_right": 318, "nodeid": "1387673.274138_5858850.996178", "id": "1387673.274138_5858850.996178", "name": "manhole_311_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387673.274138238513842, 5858850.996178055182099 ] } }, +{ "type": "Feature", "properties": { "_index": 317, "bedlevel": 749.70001220703125, "branchid": "pipe_9_E1194;pipe_9_E1195", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_312_generated", "shape": null, "area": 0.64, "streetlevel": 752.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 752.70001220703125, "distance_right": 4.8731809691594117e-07, "index_right": 319, "nodeid": "1387624.170363_5858858.384703", "id": "1387624.170363_5858858.384703", "name": "manhole_312_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387624.170362570788711, 5858858.384703231044114 ] } }, +{ "type": "Feature", "properties": { "_index": 318, "bedlevel": 749.70001220703125, "branchid": "pipe_9_E1195;pipe_9_E1196", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_313_generated", "shape": null, "area": 0.64, "streetlevel": 752.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 752.70001220703125, "distance_right": 3.021208853052767e-07, "index_right": 320, "nodeid": "1387575.715394_5858857.046076", "id": "1387575.715394_5858857.046076", "name": "manhole_313_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387575.715393897145987, 5858857.046076283790171 ] } }, +{ "type": "Feature", "properties": { "_index": 319, "bedlevel": 749.70001220703125, "branchid": "pipe_9_E1196;pipe_9_E1197", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_314_generated", "shape": null, "area": 0.64, "streetlevel": 752.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 752.70001220703125, "distance_right": 4.4818126936430864e-07, "index_right": 321, "nodeid": "1387529.438333_5858838.116818", "id": "1387529.438333_5858838.116818", "name": "manhole_314_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387529.438332577701658, 5858838.116818149574101 ] } }, +{ "type": "Feature", "properties": { "_index": 320, "bedlevel": 749.70001220703125, "branchid": "pipe_9_E1197;pipe_9_E1198", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_315_generated", "shape": null, "area": 0.64, "streetlevel": 752.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 752.70001220703125, "distance_right": 5.6845137939870927e-07, "index_right": 322, "nodeid": "1387481.179235_5858825.222028", "id": "1387481.179235_5858825.222028", "name": "manhole_315_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387481.179235466290265, 5858825.222027675248682 ] } }, +{ "type": "Feature", "properties": { "_index": 321, "bedlevel": 774.20001220703125, "branchid": "pipe_9_E1198;pipe_9_E1199", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_316_generated", "shape": null, "area": 0.64, "streetlevel": 777.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 777.20001220703125, "distance_right": 3.6917873843020322e-07, "index_right": 323, "nodeid": "1387432.215501_5858815.797907", "id": "1387432.215501_5858815.797907", "name": "manhole_316_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387432.215501294471323, 5858815.797906777821481 ] } }, +{ "type": "Feature", "properties": { "_index": 322, "bedlevel": 769.79998779296875, "branchid": "pipe_9_E1199;pipe_9_E1200", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_317_generated", "shape": null, "area": 0.64, "streetlevel": 772.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 772.79998779296875, "distance_right": 4.8304048875277775e-07, "index_right": 324, "nodeid": "1387382.431882_5858811.154251", "id": "1387382.431882_5858811.154251", "name": "manhole_317_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387382.431881646160036, 5858811.154251328669488 ] } }, +{ "type": "Feature", "properties": { "_index": 323, "bedlevel": 744.10003662109375, "branchid": "pipe_9_E1200;pipe_9_E1201", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_318_generated", "shape": null, "area": 0.64, "streetlevel": 747.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 747.10003662109375, "distance_right": 4.6235358904885766e-07, "index_right": 325, "nodeid": "1387336.607073_5858824.075685", "id": "1387336.607073_5858824.075685", "name": "manhole_318_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387336.607072548242286, 5858824.075685098767281 ] } }, +{ "type": "Feature", "properties": { "_index": 324, "bedlevel": 744.10003662109375, "branchid": "pipe_9_E1201;pipe_9_E1202", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_319_generated", "shape": null, "area": 0.64, "streetlevel": 747.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 747.10003662109375, "distance_right": 5.6873244460004577e-07, "index_right": 326, "nodeid": "1387327.458137_5858870.885960", "id": "1387327.458137_5858870.885960", "name": "manhole_319_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387327.458137275883928, 5858870.88596049696207 ] } }, +{ "type": "Feature", "properties": { "_index": 325, "bedlevel": 744.10003662109375, "branchid": "pipe_9_E1202;pipe_9_E1203", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_320_generated", "shape": null, "area": 0.64, "streetlevel": 747.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 747.10003662109375, "distance_right": 3.8904049800083803e-07, "index_right": 327, "nodeid": "1387344.619252_5858917.848376", "id": "1387344.619252_5858917.848376", "name": "manhole_320_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387344.619252334116027, 5858917.848375800997019 ] } }, +{ "type": "Feature", "properties": { "_index": 326, "bedlevel": 770.70001220703125, "branchid": "pipe_9_E1203;pipe_9_E1204", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_321_generated", "shape": null, "area": 0.64, "streetlevel": 773.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 773.70001220703125, "distance_right": 5.1999605945586677e-07, "index_right": 328, "nodeid": "1387358.089984_5858965.710650", "id": "1387358.089984_5858965.710650", "name": "manhole_321_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387358.089983508689329, 5858965.710649829357862 ] } }, +{ "type": "Feature", "properties": { "_index": 327, "bedlevel": 770.70001220703125, "branchid": "pipe_9_E1204;pipe_9_E1205", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_322_generated", "shape": null, "area": 0.64, "streetlevel": 773.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 773.70001220703125, "distance_right": 4.9281359962432306e-07, "index_right": 329, "nodeid": "1387329.564613_5859003.583583", "id": "1387329.564613_5859003.583583", "name": "manhole_322_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387329.564612702699378, 5859003.583583393134177 ] } }, +{ "type": "Feature", "properties": { "_index": 328, "bedlevel": 771.29998779296875, "branchid": "pipe_9_E1205;pipe_9_E1206", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_323_generated", "shape": null, "area": 0.64, "streetlevel": 774.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 774.29998779296875, "distance_right": 3.9854077696941929e-07, "index_right": 330, "nodeid": "1387285.783744_5858993.703192", "id": "1387285.783744_5858993.703192", "name": "manhole_323_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387285.783744251355529, 5858993.703191691078246 ] } }, +{ "type": "Feature", "properties": { "_index": 329, "bedlevel": 771.29998779296875, "branchid": "pipe_9_E1206;pipe_9_E1207", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_324_generated", "shape": null, "area": 0.64, "streetlevel": 774.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 774.29998779296875, "distance_right": 1.835562136038822e-07, "index_right": 331, "nodeid": "1387248.355973_5858961.317975", "id": "1387248.355973_5858961.317975", "name": "manhole_324_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387248.355973182013258, 5858961.31797497626394 ] } }, +{ "type": "Feature", "properties": { "_index": 330, "bedlevel": 766.4000244140625, "branchid": "pipe_9_E1207;pipe_9_E1208", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_325_generated", "shape": null, "area": 0.64, "streetlevel": 769.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 769.4000244140625, "distance_right": 5.4534265143731815e-07, "index_right": 332, "nodeid": "1387199.500434_5858963.645902", "id": "1387199.500434_5858963.645902", "name": "manhole_325_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387199.500433639157563, 5858963.645901591517031 ] } }, +{ "type": "Feature", "properties": { "_index": 331, "bedlevel": 766.4000244140625, "branchid": "pipe_9_E1208;pipe_9_E1209", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_326_generated", "shape": null, "area": 0.64, "streetlevel": 769.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 769.4000244140625, "distance_right": 2.0016300260355049e-07, "index_right": 333, "nodeid": "1387151.482699_5858977.583961", "id": "1387151.482699_5858977.583961", "name": "manhole_326_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387151.482699199579656, 5858977.583961015567183 ] } }, +{ "type": "Feature", "properties": { "_index": 332, "bedlevel": 759.60003662109375, "branchid": "pipe_9_E1209;pipe_9_E1210", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_327_generated", "shape": null, "area": 0.64, "streetlevel": 762.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.60003662109375, "distance_right": 4.0229854171678003e-07, "index_right": 334, "nodeid": "1387103.632612_5858992.082135", "id": "1387103.632612_5858992.082135", "name": "manhole_327_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387103.632611613254994, 5858992.082134889438748 ] } }, +{ "type": "Feature", "properties": { "_index": 333, "bedlevel": 759.60003662109375, "branchid": "pipe_9_E1210;pipe_9_E1211", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_328_generated", "shape": null, "area": 0.64, "streetlevel": 762.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.60003662109375, "distance_right": 4.915098453471915e-07, "index_right": 335, "nodeid": "1387055.853340_5859006.816906", "id": "1387055.853340_5859006.816906", "name": "manhole_328_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387055.853339510038495, 5859006.816905959509313 ] } }, +{ "type": "Feature", "properties": { "_index": 334, "bedlevel": 752.79998779296875, "branchid": "pipe_9_E1211;pipe_9_E1212", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_329_generated", "shape": null, "area": 0.64, "streetlevel": 755.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 755.79998779296875, "distance_right": 4.0761325042562238e-07, "index_right": 336, "nodeid": "1387008.074067_5859021.551677", "id": "1387008.074067_5859021.551677", "name": "manhole_329_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387008.074067406589165, 5859021.551677029579878 ] } }, +{ "type": "Feature", "properties": { "_index": 335, "bedlevel": 752.79998779296875, "branchid": "pipe_9_E1212;pipe_9_E1213", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_330_generated", "shape": null, "area": 0.64, "streetlevel": 755.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 755.79998779296875, "distance_right": 3.1932559379339034e-07, "index_right": 337, "nodeid": "1386960.294795_5859036.286448", "id": "1386960.294795_5859036.286448", "name": "manhole_330_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386960.294795303372666, 5859036.286448099650443 ] } }, +{ "type": "Feature", "properties": { "_index": 336, "bedlevel": 746.5, "branchid": "pipe_9_E1213;pipe_9_E1214", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_331_generated", "shape": null, "area": 0.64, "streetlevel": 749.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 749.5, "distance_right": 2.6234383268459319e-07, "index_right": 338, "nodeid": "1386912.515523_5859051.021219", "id": "1386912.515523_5859051.021219", "name": "manhole_331_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386912.515523200156167, 5859051.021219169721007 ] } }, +{ "type": "Feature", "properties": { "_index": 337, "bedlevel": 746.5, "branchid": "pipe_9_E1214;pipe_9_E1215", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_332_generated", "shape": null, "area": 0.64, "streetlevel": 749.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 749.5, "distance_right": 2.5811763091701403e-07, "index_right": 339, "nodeid": "1386864.736251_5859065.755990", "id": "1386864.736251_5859065.755990", "name": "manhole_332_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386864.736251096706837, 5859065.755990239791572 ] } }, +{ "type": "Feature", "properties": { "_index": 338, "bedlevel": 724.10003662109375, "branchid": "pipe_9_E1215;pipe_9_E1216", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_333_generated", "shape": null, "area": 0.64, "streetlevel": 727.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 727.10003662109375, "distance_right": 3.1019893050904853e-07, "index_right": 340, "nodeid": "1386816.956979_5859080.490761", "id": "1386816.956979_5859080.490761", "name": "manhole_333_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386816.956978993490338, 5859080.490761309862137 ] } }, +{ "type": "Feature", "properties": { "_index": 339, "bedlevel": 749.29998779296875, "branchid": "pipe_9_E1216;pipe_9_E1217", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_334_generated", "shape": null, "area": 0.64, "streetlevel": 752.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 752.29998779296875, "distance_right": 5.6178406168264699e-07, "index_right": 341, "nodeid": "1386769.832018_5859096.976014", "id": "1386769.832018_5859096.976014", "name": "manhole_334_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386769.832018451532349, 5859096.976014334708452 ] } }, +{ "type": "Feature", "properties": { "_index": 340, "bedlevel": 735.0, "branchid": "pipe_9_E1217;pipe_9_E1218", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_335_generated", "shape": null, "area": 0.64, "streetlevel": 738.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 738.0, "distance_right": 2.8621809563681197e-07, "index_right": 342, "nodeid": "1386724.102283_5859117.193917", "id": "1386724.102283_5859117.193917", "name": "manhole_335_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386724.102282747160643, 5859117.193917133845389 ] } }, +{ "type": "Feature", "properties": { "_index": 341, "bedlevel": 735.0, "branchid": "pipe_9_E1218;pipe_9_E1219", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_336_generated", "shape": null, "area": 0.64, "streetlevel": 738.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 738.0, "distance_right": 7.8789009124261769e-08, "index_right": 343, "nodeid": "1386678.372547_5859137.411820", "id": "1386678.372547_5859137.411820", "name": "manhole_336_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386678.372547042788938, 5859137.411819933913648 ] } }, +{ "type": "Feature", "properties": { "_index": 342, "bedlevel": 729.79998779296875, "branchid": "pipe_9_E1219;pipe_9_E1220", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_337_generated", "shape": null, "area": 0.64, "streetlevel": 732.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 732.79998779296875, "distance_right": 4.3115262751711752e-07, "index_right": 344, "nodeid": "1386632.642811_5859157.629723", "id": "1386632.642811_5859157.629723", "name": "manhole_337_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386632.642811338417232, 5859157.629722733050585 ] } }, +{ "type": "Feature", "properties": { "_index": 343, "bedlevel": 729.79998779296875, "branchid": "pipe_9_E1220;pipe_9_E1221", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_338_generated", "shape": null, "area": 0.64, "streetlevel": 732.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 732.79998779296875, "distance_right": 5.9301923802470201e-07, "index_right": 345, "nodeid": "1386586.913076_5859177.847626", "id": "1386586.913076_5859177.847626", "name": "manhole_338_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386586.913075634045526, 5859177.847625533118844 ] } }, +{ "type": "Feature", "properties": { "_index": 344, "bedlevel": 729.60003662109375, "branchid": "pipe_9_E1221;pipe_9_E1222", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_339_generated", "shape": null, "area": 0.64, "streetlevel": 732.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 732.60003662109375, "distance_right": 3.5434957598378926e-07, "index_right": 346, "nodeid": "1386541.181931_5859198.062338", "id": "1386541.181931_5859198.062338", "name": "manhole_339_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386541.181931287748739, 5859198.062337793409824 ] } }, +{ "type": "Feature", "properties": { "_index": 345, "bedlevel": 729.60003662109375, "branchid": "pipe_9_E1222;pipe_9_E1223", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_340_generated", "shape": null, "area": 0.64, "streetlevel": 732.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 732.60003662109375, "distance_right": 4.1298571283569886e-07, "index_right": 347, "nodeid": "1386495.431539_5859218.233454", "id": "1386495.431539_5859218.233454", "name": "manhole_340_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386495.431538854492828, 5859218.233453613705933 ] } }, +{ "type": "Feature", "properties": { "_index": 346, "bedlevel": 739.5, "branchid": "pipe_9_E1223;pipe_9_E1224", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_341_generated", "shape": null, "area": 0.64, "streetlevel": 742.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 742.5, "distance_right": 6.042706584474631e-07, "index_right": 348, "nodeid": "1386449.681146_5859238.404569", "id": "1386449.681146_5859238.404569", "name": "manhole_341_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386449.681146421469748, 5859238.404569433070719 ] } }, +{ "type": "Feature", "properties": { "_index": 347, "bedlevel": 739.5, "branchid": "pipe_9_E1224;pipe_9_E1225", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_342_generated", "shape": null, "area": 0.64, "streetlevel": 742.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 742.5, "distance_right": 2.8591754721493927e-07, "index_right": 349, "nodeid": "1386404.749107_5859260.314222", "id": "1386404.749107_5859260.314222", "name": "manhole_342_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386404.749107032548636, 5859260.314221715554595 ] } }, +{ "type": "Feature", "properties": { "_index": 348, "bedlevel": 714.60003662109375, "branchid": "pipe_9_E1225;pipe_9_E1226", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_343_generated", "shape": null, "area": 0.64, "streetlevel": 717.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 717.60003662109375, "distance_right": 2.8677940449835489e-07, "index_right": 350, "nodeid": "1386360.756596_5859284.020065", "id": "1386360.756596_5859284.020065", "name": "manhole_343_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386360.756595908896998, 5859284.020064728334546 ] } }, +{ "type": "Feature", "properties": { "_index": 349, "bedlevel": 714.60003662109375, "branchid": "pipe_9_E1226;pipe_9_E1227", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_344_generated", "shape": null, "area": 0.64, "streetlevel": 717.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 717.60003662109375, "distance_right": 2.2879008155258781e-07, "index_right": 351, "nodeid": "1386317.622745_5859309.307279", "id": "1386317.622745_5859309.307279", "name": "manhole_344_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386317.622744857333601, 5859309.307279178872705 ] } }, +{ "type": "Feature", "properties": { "_index": 350, "bedlevel": 708.0, "branchid": "pipe_9_E1227;pipe_9_E1228", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_345_generated", "shape": null, "area": 0.64, "streetlevel": 711.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 711.0, "distance_right": 4.1844920248290768e-07, "index_right": 352, "nodeid": "1386274.488894_5859334.594494", "id": "1386274.488894_5859334.594494", "name": "manhole_345_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386274.488893805770203, 5859334.594493629410863 ] } }, +{ "type": "Feature", "properties": { "_index": 351, "bedlevel": 714.60003662109375, "branchid": "pipe_9_E1228;pipe_9_E1229", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_346_generated", "shape": null, "area": 0.64, "streetlevel": 717.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 717.60003662109375, "distance_right": 6.2631235412604143e-07, "index_right": 353, "nodeid": "1386231.354724_5859359.881164", "id": "1386231.354724_5859359.881164", "name": "manhole_346_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386231.354723542230204, 5859359.881163572892547 ] } }, +{ "type": "Feature", "properties": { "_index": 352, "bedlevel": 736.0, "branchid": "pipe_9_E1229;pipe_9_E1230", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_347_generated", "shape": null, "area": 0.64, "streetlevel": 739.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 739.0, "distance_right": 6.7422946470908165e-07, "index_right": 354, "nodeid": "1386188.788941_5859385.978958", "id": "1386188.788941_5859385.978958", "name": "manhole_347_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386188.788941488368437, 5859385.978958465158939 ] } }, +{ "type": "Feature", "properties": { "_index": 353, "bedlevel": 736.0, "branchid": "pipe_9_E1230;pipe_9_E1231", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_348_generated", "shape": null, "area": 0.64, "streetlevel": 739.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 739.0, "distance_right": 8.8043546398989323e-08, "index_right": 355, "nodeid": "1386153.170270_5859420.751349", "id": "1386153.170270_5859420.751349", "name": "manhole_348_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386153.170269979629666, 5859420.751348914578557 ] } }, +{ "type": "Feature", "properties": { "_index": 354, "bedlevel": 736.0, "branchid": "pipe_9_E1231;pipe_9_E1232", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_349_generated", "shape": null, "area": 0.64, "streetlevel": 739.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 739.0, "distance_right": 4.3670892571283769e-07, "index_right": 356, "nodeid": "1386127.241227_5859463.084468", "id": "1386127.241227_5859463.084468", "name": "manhole_349_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386127.241226618411019, 5859463.08446778729558 ] } }, +{ "type": "Feature", "properties": { "_index": 355, "bedlevel": 767.60003662109375, "branchid": "pipe_9_E1232;pipe_9_E1233", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_350_generated", "shape": null, "area": 0.64, "streetlevel": 770.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 770.60003662109375, "distance_right": 2.8822750408817674e-07, "index_right": 357, "nodeid": "1386108.996457_5859509.052054", "id": "1386108.996457_5859509.052054", "name": "manhole_350_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386108.996456971857697, 5859509.052053713239729 ] } }, +{ "type": "Feature", "properties": { "_index": 356, "bedlevel": 767.60003662109375, "branchid": "pipe_9_E1233;pipe_9_E1234", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_351_generated", "shape": null, "area": 0.64, "streetlevel": 770.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 770.60003662109375, "distance_right": 4.1608712174096055e-07, "index_right": 358, "nodeid": "1386105.954033_5859558.959127", "id": "1386105.954033_5859558.959127", "name": "manhole_351_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386105.954033384332433, 5859558.959127158857882 ] } }, +{ "type": "Feature", "properties": { "_index": 357, "bedlevel": 767.60003662109375, "branchid": "pipe_9_E1234;pipe_9_E1235", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_352_generated", "shape": null, "area": 0.64, "streetlevel": 770.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 770.60003662109375, "distance_right": 3.5779222205411915e-07, "index_right": 359, "nodeid": "1386101.917093_5859608.782216", "id": "1386101.917093_5859608.782216", "name": "manhole_352_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386101.917093347059563, 5859608.782215913757682 ] } }, +{ "type": "Feature", "properties": { "_index": 358, "bedlevel": 776.79998779296875, "branchid": "pipe_9_E1235;pipe_9_E1236", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_353_generated", "shape": null, "area": 0.64, "streetlevel": 779.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 779.79998779296875, "distance_right": 9.182652855228106e-08, "index_right": 360, "nodeid": "1386088.458339_5859656.652666", "id": "1386088.458339_5859656.652666", "name": "manhole_353_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386088.458339030388743, 5859656.652665913105011 ] } }, +{ "type": "Feature", "properties": { "_index": 359, "bedlevel": 776.79998779296875, "branchid": "pipe_9_E1236;pipe_9_E1237", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_354_generated", "shape": null, "area": 0.64, "streetlevel": 779.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 779.79998779296875, "distance_right": 4.3106410240470186e-07, "index_right": 361, "nodeid": "1386075.652030_5859704.419184", "id": "1386075.652030_5859704.419184", "name": "manhole_354_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386075.652030121767893, 5859704.419184413738549 ] } }, +{ "type": "Feature", "properties": { "_index": 360, "bedlevel": 776.79998779296875, "branchid": "pipe_9_E1237;pipe_9_E1238", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_355_generated", "shape": null, "area": 0.64, "streetlevel": 779.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 779.79998779296875, "distance_right": 5.9419274352607342e-07, "index_right": 362, "nodeid": "1386076.574771_5859754.410392", "id": "1386076.574771_5859754.410392", "name": "manhole_355_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386076.574770522769541, 5859754.410392354242504 ] } }, +{ "type": "Feature", "properties": { "_index": 361, "bedlevel": 777.79998779296875, "branchid": "pipe_9_E1238;pipe_9_E1239", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_356_generated", "shape": null, "area": 0.64, "streetlevel": 780.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 780.79998779296875, "distance_right": 3.0404508552976817e-07, "index_right": 363, "nodeid": "1386077.497511_5859804.401600", "id": "1386077.497511_5859804.401600", "name": "manhole_356_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386077.497510923538357, 5859804.401600294746459 ] } }, +{ "type": "Feature", "properties": { "_index": 362, "bedlevel": 777.79998779296875, "branchid": "pipe_9_E1239", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_357_generated", "shape": null, "area": 0.64, "streetlevel": 780.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 780.79998779296875, "distance_right": 4.0088765079104887e-07, "index_right": 364, "nodeid": "1386078.420251_5859854.392808", "id": "1386078.420251_5859854.392808", "name": "manhole_357_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386078.420251324307173, 5859854.392808235250413 ] } }, +{ "type": "Feature", "properties": { "_index": 363, "bedlevel": 811.29998779296875, "branchid": "pipe_10_E195", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_358_generated", "shape": null, "area": 0.64, "streetlevel": 814.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 814.29998779296875, "distance_right": 4.5480020130277707e-07, "index_right": 365, "nodeid": "1384050.267681_5856698.702002", "id": "1384050.267681_5856698.702002", "name": "manhole_358_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384050.267680946970358, 5856698.702001548372209 ] } }, +{ "type": "Feature", "properties": { "_index": 363, "bedlevel": 799.9000244140625, "branchid": "pipe_10_E195;pipe_10_E196", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_359_generated", "shape": null, "area": 0.64, "streetlevel": 802.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 802.9000244140625, "distance_right": 2.5012654807533162e-07, "index_right": 366, "nodeid": "1384085.778962_5856733.441067", "id": "1384085.778962_5856733.441067", "name": "manhole_359_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384085.778961833100766, 5856733.441067186184227 ] } }, +{ "type": "Feature", "properties": { "_index": 364, "bedlevel": 799.9000244140625, "branchid": "pipe_10_E196;pipe_10_E197", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_360_generated", "shape": null, "area": 0.64, "streetlevel": 802.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 802.9000244140625, "distance_right": 1.9869950468383852e-07, "index_right": 367, "nodeid": "1384122.993944_5856766.592180", "id": "1384122.993944_5856766.592180", "name": "manhole_360_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384122.993944165529683, 5856766.592179889790714 ] } }, +{ "type": "Feature", "properties": { "_index": 365, "bedlevel": 813.29998779296875, "branchid": "pipe_10_E197;pipe_10_E198", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_361_generated", "shape": null, "area": 0.64, "streetlevel": 816.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 816.29998779296875, "distance_right": 3.0801021440480768e-07, "index_right": 368, "nodeid": "1384160.350960_5856799.578122", "id": "1384160.350960_5856799.578122", "name": "manhole_361_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384160.350959801580757, 5856799.578122235834599 ] } }, +{ "type": "Feature", "properties": { "_index": 366, "bedlevel": 797.79998779296875, "branchid": "pipe_10_E198;pipe_10_E199", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_362_generated", "shape": null, "area": 0.64, "streetlevel": 800.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 800.79998779296875, "distance_right": 3.667194985852315e-07, "index_right": 369, "nodeid": "1384198.384374_5856831.724873", "id": "1384198.384374_5856831.724873", "name": "manhole_362_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384198.384374253917485, 5856831.724873264320195 ] } }, +{ "type": "Feature", "properties": { "_index": 367, "bedlevel": 797.79998779296875, "branchid": "pipe_10_E199;pipe_10_E200", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_363_generated", "shape": null, "area": 0.64, "streetlevel": 800.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 800.79998779296875, "distance_right": 4.676575474857736e-07, "index_right": 370, "nodeid": "1384230.112839_5856870.159957", "id": "1384230.112839_5856870.159957", "name": "manhole_363_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384230.112839305773377, 5856870.159957353956997 ] } }, +{ "type": "Feature", "properties": { "_index": 368, "bedlevel": 790.9000244140625, "branchid": "pipe_10_E200;pipe_10_E201", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_364_generated", "shape": null, "area": 0.64, "streetlevel": 793.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 793.9000244140625, "distance_right": 3.989035851645309e-07, "index_right": 371, "nodeid": "1384259.121702_5856910.628997", "id": "1384259.121702_5856910.628997", "name": "manhole_364_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384259.121702386764809, 5856910.628996902145445 ] } }, +{ "type": "Feature", "properties": { "_index": 369, "bedlevel": 804.60003662109375, "branchid": "pipe_10_E201;pipe_10_E202", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_365_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 4.0937169419879659e-07, "index_right": 372, "nodeid": "1384287.023719_5856951.925833", "id": "1384287.023719_5856951.925833", "name": "manhole_365_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384287.023718592710793, 5856951.925833041779697 ] } }, +{ "type": "Feature", "properties": { "_index": 370, "bedlevel": 804.60003662109375, "branchid": "pipe_10_E202;pipe_10_E203", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_366_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 5.4900122883217553e-07, "index_right": 373, "nodeid": "1384314.929269_5856993.220281", "id": "1384314.929269_5856993.220281", "name": "manhole_366_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384314.929269487503916, 5856993.22028074786067 ] } }, +{ "type": "Feature", "properties": { "_index": 371, "bedlevel": 804.60003662109375, "branchid": "pipe_10_E203;pipe_10_E204", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_367_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 4.4153137935343798e-07, "index_right": 374, "nodeid": "1384344.819753_5857033.056209", "id": "1384344.819753_5857033.056209", "name": "manhole_367_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384344.819752591196448, 5857033.056208833120763 ] } }, +{ "type": "Feature", "properties": { "_index": 372, "bedlevel": 804.60003662109375, "branchid": "pipe_10_E204;pipe_10_E205", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_368_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 5.2277323961967174e-07, "index_right": 375, "nodeid": "1384375.891110_5857072.024426", "id": "1384375.891110_5857072.024426", "name": "manhole_368_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384375.891110281459987, 5857072.024425559677184 ] } }, +{ "type": "Feature", "properties": { "_index": 373, "bedlevel": 804.60003662109375, "branchid": "pipe_10_E205;pipe_10_E206", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_369_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 3.2330989267580892e-07, "index_right": 376, "nodeid": "1384412.732156_5857105.507668", "id": "1384412.732156_5857105.507668", "name": "manhole_369_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384412.732155854580924, 5857105.507668288424611 ] } }, +{ "type": "Feature", "properties": { "_index": 374, "bedlevel": 792.9000244140625, "branchid": "pipe_10_E206;pipe_10_E207", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_370_generated", "shape": null, "area": 0.64, "streetlevel": 795.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 795.9000244140625, "distance_right": 5.2820652785107969e-07, "index_right": 377, "nodeid": "1384450.079483_5857138.509612", "id": "1384450.079483_5857138.509612", "name": "manhole_370_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384450.07948348694481, 5857138.509612204506993 ] } }, +{ "type": "Feature", "properties": { "_index": 375, "bedlevel": 792.9000244140625, "branchid": "pipe_10_E207;pipe_10_E208", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_371_generated", "shape": null, "area": 0.64, "streetlevel": 795.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 795.9000244140625, "distance_right": 3.553435013241558e-07, "index_right": 378, "nodeid": "1384487.426863_5857171.511497", "id": "1384487.426863_5857171.511497", "name": "manhole_371_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384487.42686335532926, 5857171.511497005820274 ] } }, +{ "type": "Feature", "properties": { "_index": 376, "bedlevel": 802.0, "branchid": "pipe_10_E208;pipe_10_E209", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_372_generated", "shape": null, "area": 0.64, "streetlevel": 805.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 805.0, "distance_right": 3.8657915864597202e-07, "index_right": 379, "nodeid": "1384525.207760_5857204.014278", "id": "1384525.207760_5857204.014278", "name": "manhole_372_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384525.207759798038751, 5857204.014277670532465 ] } }, +{ "type": "Feature", "properties": { "_index": 377, "bedlevel": 793.29998779296875, "branchid": "pipe_10_E209;pipe_10_E210", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_373_generated", "shape": null, "area": 0.64, "streetlevel": 796.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 796.29998779296875, "distance_right": 4.2528319184092202e-07, "index_right": 380, "nodeid": "1384563.111989_5857236.375066", "id": "1384563.111989_5857236.375066", "name": "manhole_373_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384563.111988977529109, 5857236.375065575353801 ] } }, +{ "type": "Feature", "properties": { "_index": 378, "bedlevel": 793.29998779296875, "branchid": "pipe_10_E210;pipe_10_E211", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_374_generated", "shape": null, "area": 0.64, "streetlevel": 796.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 796.29998779296875, "distance_right": 5.0546374469285607e-07, "index_right": 381, "nodeid": "1384601.016218_5857268.735853", "id": "1384601.016218_5857268.735853", "name": "manhole_374_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384601.016218156786636, 5857268.735853480175138 ] } }, +{ "type": "Feature", "properties": { "_index": 379, "bedlevel": 783.10003662109375, "branchid": "pipe_10_E211;pipe_10_E212", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_375_generated", "shape": null, "area": 0.64, "streetlevel": 786.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 786.10003662109375, "distance_right": 5.1070928007990266e-07, "index_right": 382, "nodeid": "1384638.920447_5857301.096641", "id": "1384638.920447_5857301.096641", "name": "manhole_375_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384638.920447336044163, 5857301.096641384996474 ] } }, +{ "type": "Feature", "properties": { "_index": 380, "bedlevel": 791.29998779296875, "branchid": "pipe_10_E212;pipe_10_E213", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_376_generated", "shape": null, "area": 0.64, "streetlevel": 794.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 794.29998779296875, "distance_right": 2.7491413546788394e-07, "index_right": 383, "nodeid": "1384669.604955_5857340.313405", "id": "1384669.604955_5857340.313405", "name": "manhole_376_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384669.604954990325496, 5857340.313404724933207 ] } }, +{ "type": "Feature", "properties": { "_index": 381, "bedlevel": 791.29998779296875, "branchid": "pipe_10_E213;pipe_10_E214", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_377_generated", "shape": null, "area": 0.64, "streetlevel": 794.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 794.29998779296875, "distance_right": 3.0550370542163772e-07, "index_right": 384, "nodeid": "1384699.518248_5857380.104403", "id": "1384699.518248_5857380.104403", "name": "manhole_377_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384699.518247769214213, 5857380.104403200559318 ] } }, +{ "type": "Feature", "properties": { "_index": 382, "bedlevel": 791.29998779296875, "branchid": "pipe_10_E214;pipe_10_E215", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_378_generated", "shape": null, "area": 0.64, "streetlevel": 794.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 794.29998779296875, "distance_right": 4.6591738879886883e-07, "index_right": 385, "nodeid": "1384719.806332_5857425.627417", "id": "1384719.806332_5857425.627417", "name": "manhole_378_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384719.806332413339987, 5857425.627417215146124 ] } }, +{ "type": "Feature", "properties": { "_index": 383, "bedlevel": 779.0, "branchid": "pipe_10_E215;pipe_10_E216", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_379_generated", "shape": null, "area": 0.64, "streetlevel": 782.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 782.0, "distance_right": 2.3711637815636632e-07, "index_right": 386, "nodeid": "1384740.094417_5857471.150431", "id": "1384740.094417_5857471.150431", "name": "manhole_379_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384740.094417057465762, 5857471.150431229732931 ] } }, +{ "type": "Feature", "properties": { "_index": 384, "bedlevel": 786.70001220703125, "branchid": "pipe_10_E216;pipe_10_E217", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_380_generated", "shape": null, "area": 0.64, "streetlevel": 789.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 789.70001220703125, "distance_right": 3.8553183229025237e-07, "index_right": 387, "nodeid": "1384760.382502_5857516.673445", "id": "1384760.382502_5857516.673445", "name": "manhole_380_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384760.382501701591536, 5857516.673445244319737 ] } }, +{ "type": "Feature", "properties": { "_index": 385, "bedlevel": 786.70001220703125, "branchid": "pipe_10_E217;pipe_10_E218", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_381_generated", "shape": null, "area": 0.64, "streetlevel": 789.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 789.70001220703125, "distance_right": 4.319475330982492e-07, "index_right": 388, "nodeid": "1384780.670586_5857562.196459", "id": "1384780.670586_5857562.196459", "name": "manhole_381_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384780.670586345717311, 5857562.196459258906543 ] } }, +{ "type": "Feature", "properties": { "_index": 386, "bedlevel": 793.5, "branchid": "pipe_10_E218;pipe_10_E219", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_382_generated", "shape": null, "area": 0.64, "streetlevel": 796.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 796.5, "distance_right": 4.9625998791457793e-07, "index_right": 389, "nodeid": "1384802.672203_5857606.838341", "id": "1384802.672203_5857606.838341", "name": "manhole_382_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384802.672203443944454, 5857606.838341221213341 ] } }, +{ "type": "Feature", "properties": { "_index": 387, "bedlevel": 768.9000244140625, "branchid": "pipe_10_E219;pipe_10_E220", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_383_generated", "shape": null, "area": 0.64, "streetlevel": 771.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 771.9000244140625, "distance_right": 2.8229532162483524e-07, "index_right": 390, "nodeid": "1384827.896526_5857649.823045", "id": "1384827.896526_5857649.823045", "name": "manhole_383_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384827.896526007680222, 5857649.823044718243182 ] } }, +{ "type": "Feature", "properties": { "_index": 388, "bedlevel": 768.9000244140625, "branchid": "pipe_10_E220;pipe_10_E221", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_384_generated", "shape": null, "area": 0.64, "streetlevel": 771.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 771.9000244140625, "distance_right": 2.0692567208455349e-07, "index_right": 391, "nodeid": "1384854.757883_5857691.606821", "id": "1384854.757883_5857691.606821", "name": "manhole_384_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384854.757882944308221, 5857691.606820800341666 ] } }, +{ "type": "Feature", "properties": { "_index": 389, "bedlevel": 768.9000244140625, "branchid": "pipe_10_E221;pipe_10_E222", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_385_generated", "shape": null, "area": 0.64, "streetlevel": 771.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 771.9000244140625, "distance_right": 1.9931880625148583e-07, "index_right": 392, "nodeid": "1384888.185769_5857728.573395", "id": "1384888.185769_5857728.573395", "name": "manhole_385_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384888.185768931638449, 5857728.573395187035203 ] } }, +{ "type": "Feature", "properties": { "_index": 390, "bedlevel": 754.9000244140625, "branchid": "pipe_10_E222;pipe_10_E223", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_386_generated", "shape": null, "area": 0.64, "streetlevel": 757.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 757.9000244140625, "distance_right": 4.3330183135741007e-07, "index_right": 393, "nodeid": "1384921.613655_5857765.539970", "id": "1384921.613655_5857765.539970", "name": "manhole_386_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384921.613654918735847, 5857765.539969574660063 ] } }, +{ "type": "Feature", "properties": { "_index": 391, "bedlevel": 754.9000244140625, "branchid": "pipe_10_E223;pipe_10_E224", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_387_generated", "shape": null, "area": 0.64, "streetlevel": 757.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 757.9000244140625, "distance_right": 3.5666888496789524e-07, "index_right": 394, "nodeid": "1384956.145454_5857801.445757", "id": "1384956.145454_5857801.445757", "name": "manhole_387_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384956.145453942706808, 5857801.445756647735834 ] } }, +{ "type": "Feature", "properties": { "_index": 392, "bedlevel": 754.9000244140625, "branchid": "pipe_10_E224;pipe_10_E225", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_388_generated", "shape": null, "area": 0.64, "streetlevel": 757.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 757.9000244140625, "distance_right": 5.9257077545387882e-07, "index_right": 395, "nodeid": "1384991.751307_5857836.319449", "id": "1384991.751307_5857836.319449", "name": "manhole_388_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384991.751306539867073, 5857836.319449373520911 ] } }, +{ "type": "Feature", "properties": { "_index": 393, "bedlevel": 743.0, "branchid": "pipe_10_E225;pipe_10_E226", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_389_generated", "shape": null, "area": 0.64, "streetlevel": 746.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 746.0, "distance_right": 1.6952005672566127e-07, "index_right": 396, "nodeid": "1385027.357159_5857871.193142", "id": "1385027.357159_5857871.193142", "name": "manhole_389_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385027.357159137027338, 5857871.193142099305987 ] } }, +{ "type": "Feature", "properties": { "_index": 394, "bedlevel": 752.79998779296875, "branchid": "pipe_10_E226;pipe_10_E227", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_390_generated", "shape": null, "area": 0.64, "streetlevel": 755.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 755.79998779296875, "distance_right": 3.183628517451925e-07, "index_right": 397, "nodeid": "1385062.963012_5857906.066835", "id": "1385062.963012_5857906.066835", "name": "manhole_390_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385062.963011734187603, 5857906.066834825091064 ] } }, +{ "type": "Feature", "properties": { "_index": 395, "bedlevel": 725.60003662109375, "branchid": "pipe_10_E227;pipe_10_E228", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_391_generated", "shape": null, "area": 0.64, "streetlevel": 728.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 728.60003662109375, "distance_right": 5.5717618408289852e-07, "index_right": 398, "nodeid": "1385098.568864_5857940.940528", "id": "1385098.568864_5857940.940528", "name": "manhole_391_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385098.568864331347868, 5857940.940527551807463 ] } }, +{ "type": "Feature", "properties": { "_index": 396, "bedlevel": 725.60003662109375, "branchid": "pipe_10_E228;pipe_10_E229", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_392_generated", "shape": null, "area": 0.64, "streetlevel": 728.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 728.60003662109375, "distance_right": 4.1749358665480613e-07, "index_right": 399, "nodeid": "1385135.753846_5857974.029479", "id": "1385135.753846_5857974.029479", "name": "manhole_392_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385135.753846400883049, 5857974.029479116201401 ] } }, +{ "type": "Feature", "properties": { "_index": 397, "bedlevel": 725.60003662109375, "branchid": "pipe_10_E229;pipe_10_E230", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_393_generated", "shape": null, "area": 0.64, "streetlevel": 728.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 728.60003662109375, "distance_right": 2.2747351319038044e-07, "index_right": 400, "nodeid": "1385175.738456_5858003.622976", "id": "1385175.738456_5858003.622976", "name": "manhole_393_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385175.738456205930561, 5858003.622975903563201 ] } }, +{ "type": "Feature", "properties": { "_index": 398, "bedlevel": 732.60003662109375, "branchid": "pipe_10_E230;pipe_10_E231", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_394_generated", "shape": null, "area": 0.64, "streetlevel": 735.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 735.60003662109375, "distance_right": 3.566935824899918e-07, "index_right": 401, "nodeid": "1385218.653757_5858028.965197", "id": "1385218.653757_5858028.965197", "name": "manhole_394_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385218.653756857383996, 5858028.965196672827005 ] } }, +{ "type": "Feature", "properties": { "_index": 399, "bedlevel": 732.60003662109375, "branchid": "pipe_10_E231;pipe_10_E232", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_395_generated", "shape": null, "area": 0.64, "streetlevel": 735.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 735.60003662109375, "distance_right": 2.440171783151832e-07, "index_right": 402, "nodeid": "1385262.454937_5858052.706983", "id": "1385262.454937_5858052.706983", "name": "manhole_395_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385262.454936756985262, 5858052.706982978619635 ] } }, +{ "type": "Feature", "properties": { "_index": 400, "bedlevel": 739.0, "branchid": "pipe_10_E232;pipe_10_E233", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_396_generated", "shape": null, "area": 0.64, "streetlevel": 742.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 742.0, "distance_right": 3.1389025035042856e-07, "index_right": 403, "nodeid": "1385306.715555_5858075.618745", "id": "1385306.715555_5858075.618745", "name": "manhole_396_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385306.715555034345016, 5858075.618745312094688 ] } }, +{ "type": "Feature", "properties": { "_index": 401, "bedlevel": 739.0, "branchid": "pipe_10_E233;pipe_10_E234", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_397_generated", "shape": null, "area": 0.64, "streetlevel": 742.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 742.0, "distance_right": 4.7303629503344029e-07, "index_right": 404, "nodeid": "1385350.976173_5858098.530508", "id": "1385350.976173_5858098.530508", "name": "manhole_397_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385350.97617331170477, 5858098.530507644638419 ] } }, +{ "type": "Feature", "properties": { "_index": 402, "bedlevel": 733.0, "branchid": "pipe_10_E234;pipe_10_E235", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_398_generated", "shape": null, "area": 0.64, "streetlevel": 736.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 736.0, "distance_right": 4.1132101639328379e-07, "index_right": 405, "nodeid": "1385395.236792_5858121.442270", "id": "1385395.236792_5858121.442270", "name": "manhole_398_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385395.236791589297354, 5858121.442269978113472 ] } }, +{ "type": "Feature", "properties": { "_index": 403, "bedlevel": 733.0, "branchid": "pipe_10_E235;pipe_10_E236", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_399_generated", "shape": null, "area": 0.64, "streetlevel": 736.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 736.0, "distance_right": 3.3846440994221831e-07, "index_right": 406, "nodeid": "1385439.497410_5858144.354032", "id": "1385439.497410_5858144.354032", "name": "manhole_399_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385439.497409866657108, 5858144.354032310657203 ] } }, +{ "type": "Feature", "properties": { "_index": 404, "bedlevel": 734.9000244140625, "branchid": "pipe_10_E236;pipe_10_E237", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_400_generated", "shape": null, "area": 0.64, "streetlevel": 737.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 737.9000244140625, "distance_right": 3.8384905064986902e-07, "index_right": 407, "nodeid": "1385483.758028_5858167.265795", "id": "1385483.758028_5858167.265795", "name": "manhole_400_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385483.758028144016862, 5858167.265794644132257 ] } }, +{ "type": "Feature", "properties": { "_index": 405, "bedlevel": 734.9000244140625, "branchid": "pipe_10_E237;pipe_10_E238", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_401_generated", "shape": null, "area": 0.64, "streetlevel": 737.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 737.9000244140625, "distance_right": 4.2201580210351053e-07, "index_right": 408, "nodeid": "1385528.018646_5858190.177557", "id": "1385528.018646_5858190.177557", "name": "manhole_401_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385528.018646421376616, 5858190.17755697760731 ] } }, +{ "type": "Feature", "properties": { "_index": 406, "bedlevel": 724.29998779296875, "branchid": "pipe_10_E238;pipe_10_E239", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_402_generated", "shape": null, "area": 0.64, "streetlevel": 727.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 727.29998779296875, "distance_right": 3.5470585152500708e-07, "index_right": 409, "nodeid": "1385571.606102_5858214.277655", "id": "1385571.606102_5858214.277655", "name": "manhole_402_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385571.606102279853076, 5858214.277655217796564 ] } }, +{ "type": "Feature", "properties": { "_index": 407, "bedlevel": 724.29998779296875, "branchid": "pipe_10_E239;pipe_10_E240", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_403_generated", "shape": null, "area": 0.64, "streetlevel": 727.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 727.29998779296875, "distance_right": 1.7555615806898356e-07, "index_right": 410, "nodeid": "1385614.013401_5858240.461089", "id": "1385614.013401_5858240.461089", "name": "manhole_403_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385614.013400863157585, 5858240.461089110001922 ] } }, +{ "type": "Feature", "properties": { "_index": 408, "bedlevel": 687.60003662109375, "branchid": "pipe_10_E240;pipe_10_E241", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_404_generated", "shape": null, "area": 0.64, "streetlevel": 690.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 690.60003662109375, "distance_right": 4.4657305906836809e-07, "index_right": 411, "nodeid": "1385656.420699_5858266.644523", "id": "1385656.420699_5858266.644523", "name": "manhole_404_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385656.420699446462095, 5858266.644523002207279 ] } }, +{ "type": "Feature", "properties": { "_index": 409, "bedlevel": 730.60003662109375, "branchid": "pipe_10_E241;pipe_10_E242", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_405_generated", "shape": null, "area": 0.64, "streetlevel": 733.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 733.60003662109375, "distance_right": 4.9396989618903532e-07, "index_right": 412, "nodeid": "1385698.773112_5858292.896190", "id": "1385698.773112_5858292.896190", "name": "manhole_405_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385698.773111530812457, 5858292.8961898451671 ] } }, +{ "type": "Feature", "properties": { "_index": 410, "bedlevel": 730.60003662109375, "branchid": "pipe_10_E242;pipe_10_E243", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_406_generated", "shape": null, "area": 0.64, "streetlevel": 733.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 733.60003662109375, "distance_right": 5.9111518677801371e-07, "index_right": 413, "nodeid": "1385733.435650_5858328.707635", "id": "1385733.435650_5858328.707635", "name": "manhole_406_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385733.435650466475636, 5858328.707634637132287 ] } }, +{ "type": "Feature", "properties": { "_index": 411, "bedlevel": 718.60003662109375, "branchid": "pipe_10_E243;pipe_10_E244", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_407_generated", "shape": null, "area": 0.64, "streetlevel": 721.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 721.60003662109375, "distance_right": 5.8739235381329021e-07, "index_right": 414, "nodeid": "1385768.098189_5858364.519079", "id": "1385768.098189_5858364.519079", "name": "manhole_407_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385768.098189401905984, 5858364.519079428166151 ] } }, +{ "type": "Feature", "properties": { "_index": 412, "bedlevel": 718.60003662109375, "branchid": "pipe_10_E244;pipe_10_E245", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_408_generated", "shape": null, "area": 0.64, "streetlevel": 721.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 721.60003662109375, "distance_right": 3.8476255406641031e-07, "index_right": 415, "nodeid": "1385795.882535_5858405.467094", "id": "1385795.882535_5858405.467094", "name": "manhole_408_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385795.882535298354924, 5858405.467093757353723 ] } }, +{ "type": "Feature", "properties": { "_index": 413, "bedlevel": 736.0, "branchid": "pipe_10_E245;pipe_10_E246", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_409_generated", "shape": null, "area": 0.64, "streetlevel": 739.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 739.0, "distance_right": 3.3645639254133238e-07, "index_right": 416, "nodeid": "1385820.377635_5858448.871486", "id": "1385820.377635_5858448.871486", "name": "manhole_409_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385820.377634756267071, 5858448.871486231684685 ] } }, +{ "type": "Feature", "properties": { "_index": 414, "bedlevel": 724.79998779296875, "branchid": "pipe_10_E246;pipe_10_E247", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_410_generated", "shape": null, "area": 0.64, "streetlevel": 727.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 727.79998779296875, "distance_right": 3.9048475593888301e-07, "index_right": 417, "nodeid": "1385841.084314_5858493.920932", "id": "1385841.084314_5858493.920932", "name": "manhole_410_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385841.084314390551299, 5858493.920932004228234 ] } }, +{ "type": "Feature", "properties": { "_index": 415, "bedlevel": 724.79998779296875, "branchid": "pipe_10_E247;pipe_10_E248", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_411_generated", "shape": null, "area": 0.64, "streetlevel": 727.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 727.79998779296875, "distance_right": 4.1240584132304262e-07, "index_right": 418, "nodeid": "1385856.076262_5858541.451898", "id": "1385856.076262_5858541.451898", "name": "manhole_411_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385856.076261736918241, 5858541.451897682622075 ] } }, +{ "type": "Feature", "properties": { "_index": 416, "bedlevel": 731.9000244140625, "branchid": "pipe_10_E248;pipe_10_E249", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_412_generated", "shape": null, "area": 0.64, "streetlevel": 734.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 734.9000244140625, "distance_right": 3.9323655141917895e-07, "index_right": 419, "nodeid": "1385865.668900_5858590.250007", "id": "1385865.668900_5858590.250007", "name": "manhole_412_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385865.668899663724005, 5858590.250006795860827 ] } }, +{ "type": "Feature", "properties": { "_index": 417, "bedlevel": 731.9000244140625, "branchid": "pipe_10_E249;pipe_10_E250", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_413_generated", "shape": null, "area": 0.64, "streetlevel": 734.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 734.9000244140625, "distance_right": 4.9549867528789424e-07, "index_right": 420, "nodeid": "1385873.387287_5858639.487977", "id": "1385873.387287_5858639.487977", "name": "manhole_413_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385873.387286560609937, 5858639.487976770848036 ] } }, +{ "type": "Feature", "properties": { "_index": 418, "bedlevel": 748.4000244140625, "branchid": "pipe_10_E250;pipe_10_E251", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_414_generated", "shape": null, "area": 0.64, "streetlevel": 751.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 751.4000244140625, "distance_right": 2.5224403860867615e-07, "index_right": 421, "nodeid": "1385875.017950_5858689.287253", "id": "1385875.017950_5858689.287253", "name": "manhole_414_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385875.017949819331989, 5858689.287253175862134 ] } }, +{ "type": "Feature", "properties": { "_index": 419, "bedlevel": 748.4000244140625, "branchid": "pipe_10_E251;pipe_10_E252", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_415_generated", "shape": null, "area": 0.64, "streetlevel": 751.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 751.4000244140625, "distance_right": 5.6460120498363627e-07, "index_right": 422, "nodeid": "1385876.432929_5858739.106416", "id": "1385876.432929_5858739.106416", "name": "manhole_415_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385876.432928551919758, 5858739.106416343711317 ] } }, +{ "type": "Feature", "properties": { "_index": 420, "bedlevel": 748.4000244140625, "branchid": "pipe_10_E252;pipe_10_E253", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_416_generated", "shape": null, "area": 0.64, "streetlevel": 751.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 751.4000244140625, "distance_right": 4.8251054346948512e-07, "index_right": 423, "nodeid": "1385878.329822_5858788.908142", "id": "1385878.329822_5858788.908142", "name": "manhole_416_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385878.329821793129668, 5858788.908141564577818 ] } }, +{ "type": "Feature", "properties": { "_index": 421, "bedlevel": 756.70001220703125, "branchid": "pipe_10_E253;pipe_10_E254", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_417_generated", "shape": null, "area": 0.64, "streetlevel": 759.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 759.70001220703125, "distance_right": 2.4793227757235602e-07, "index_right": 424, "nodeid": "1385880.519215_5858838.699283", "id": "1385880.519215_5858838.699283", "name": "manhole_417_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385880.51921496167779, 5858838.69928275514394 ] } }, +{ "type": "Feature", "properties": { "_index": 422, "bedlevel": 756.70001220703125, "branchid": "pipe_10_E254;pipe_10_E255", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_418_generated", "shape": null, "area": 0.64, "streetlevel": 759.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 759.70001220703125, "distance_right": 4.9687526799931372e-07, "index_right": 425, "nodeid": "1385882.620351_5858888.493530", "id": "1385882.620351_5858888.493530", "name": "manhole_418_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385882.620351102668792, 5858888.493530485779047 ] } }, +{ "type": "Feature", "properties": { "_index": 423, "bedlevel": 756.70001220703125, "branchid": "pipe_10_E255;pipe_10_E256", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_419_generated", "shape": null, "area": 0.64, "streetlevel": 759.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 759.70001220703125, "distance_right": 4.8876958658520276e-07, "index_right": 426, "nodeid": "1385883.937444_5858938.315378", "id": "1385883.937444_5858938.315378", "name": "manhole_419_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385883.937443709466606, 5858938.315377607010305 ] } }, +{ "type": "Feature", "properties": { "_index": 424, "bedlevel": 763.10003662109375, "branchid": "pipe_10_E256;pipe_10_E257", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_420_generated", "shape": null, "area": 0.64, "streetlevel": 766.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 766.10003662109375, "distance_right": 5.5059992250426879e-07, "index_right": 427, "nodeid": "1385885.254539_5858988.137225", "id": "1385885.254539_5858988.137225", "name": "manhole_420_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385885.254538560518995, 5858988.137224668636918 ] } }, +{ "type": "Feature", "properties": { "_index": 425, "bedlevel": 763.10003662109375, "branchid": "pipe_10_E257;pipe_10_E258", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_421_generated", "shape": null, "area": 0.64, "streetlevel": 766.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 766.10003662109375, "distance_right": 4.3659669481212074e-07, "index_right": 428, "nodeid": "1385890.650534_5859037.630401", "id": "1385890.650534_5859037.630401", "name": "manhole_421_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385890.650534195825458, 5859037.630400610156357 ] } }, +{ "type": "Feature", "properties": { "_index": 426, "bedlevel": 763.10003662109375, "branchid": "pipe_10_E258;pipe_10_E259", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_422_generated", "shape": null, "area": 0.64, "streetlevel": 766.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 766.10003662109375, "distance_right": 1.9950746892356647e-07, "index_right": 429, "nodeid": "1385901.777443_5859086.092394", "id": "1385901.777443_5859086.092394", "name": "manhole_422_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385901.777442803606391, 5859086.09239396546036 ] } }, +{ "type": "Feature", "properties": { "_index": 427, "bedlevel": 765.60003662109375, "branchid": "pipe_10_E259;pipe_10_E260", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_423_generated", "shape": null, "area": 0.64, "streetlevel": 768.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 768.60003662109375, "distance_right": 4.4190839080191394e-07, "index_right": 430, "nodeid": "1385915.397955_5859134.034368", "id": "1385915.397955_5859134.034368", "name": "manhole_423_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385915.397954803425819, 5859134.03436760418117 ] } }, +{ "type": "Feature", "properties": { "_index": 428, "bedlevel": 759.79998779296875, "branchid": "pipe_10_E260;pipe_10_E261", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_424_generated", "shape": null, "area": 0.64, "streetlevel": 762.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.79998779296875, "distance_right": 4.988545283431086e-07, "index_right": 431, "nodeid": "1385928.426053_5859182.139209", "id": "1385928.426053_5859182.139209", "name": "manhole_424_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385928.42605347908102, 5859182.139209139160812 ] } }, +{ "type": "Feature", "properties": { "_index": 429, "bedlevel": 759.5, "branchid": "pipe_10_E261;pipe_10_E262", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_425_generated", "shape": null, "area": 0.64, "streetlevel": 762.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.5, "distance_right": 5.2005172650962332e-07, "index_right": 432, "nodeid": "1385941.228082_5859230.306202", "id": "1385941.228082_5859230.306202", "name": "manhole_425_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385941.228082312969491, 5859230.306202415376902 ] } }, +{ "type": "Feature", "properties": { "_index": 430, "bedlevel": 759.5, "branchid": "pipe_10_E262;pipe_10_E263", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_426_generated", "shape": null, "area": 0.64, "streetlevel": 762.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.5, "distance_right": 2.8382466111334913e-07, "index_right": 433, "nodeid": "1385945.092689_5859279.734331", "id": "1385945.092689_5859279.734331", "name": "manhole_426_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385945.092689140234143, 5859279.734331246465445 ] } }, +{ "type": "Feature", "properties": { "_index": 431, "bedlevel": 759.5, "branchid": "pipe_10_E263;pipe_10_E264", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_427_generated", "shape": null, "area": 0.64, "streetlevel": 762.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.5, "distance_right": 4.5600920280355245e-07, "index_right": 434, "nodeid": "1385937.902412_5859328.779896", "id": "1385937.902412_5859328.779896", "name": "manhole_427_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385937.902412303024903, 5859328.779896341264248 ] } }, +{ "type": "Feature", "properties": { "_index": 432, "bedlevel": 775.0, "branchid": "pipe_10_E264;pipe_10_E265", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_428_generated", "shape": null, "area": 0.64, "streetlevel": 778.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 778.0, "distance_right": 3.5119784074524645e-07, "index_right": 435, "nodeid": "1385932.795076_5859378.173214", "id": "1385932.795076_5859378.173214", "name": "manhole_428_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385932.795075723901391, 5859378.173214216716588 ] } }, +{ "type": "Feature", "properties": { "_index": 433, "bedlevel": 775.0, "branchid": "pipe_10_E265;pipe_10_E266", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_429_generated", "shape": null, "area": 0.64, "streetlevel": 778.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 778.0, "distance_right": 4.695879513954162e-07, "index_right": 436, "nodeid": "1385937.702696_5859427.770255", "id": "1385937.702696_5859427.770255", "name": "manhole_429_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385937.702695531537756, 5859427.770254967734218 ] } }, +{ "type": "Feature", "properties": { "_index": 434, "bedlevel": 775.0, "branchid": "pipe_10_E266;pipe_10_E267", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_430_generated", "shape": null, "area": 0.64, "streetlevel": 778.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 778.0, "distance_right": 1.8520459362715071e-07, "index_right": 437, "nodeid": "1385939.035938_5859477.502304", "id": "1385939.035938_5859477.502304", "name": "manhole_430_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385939.035937832202762, 5859477.50230407807976 ] } }, +{ "type": "Feature", "properties": { "_index": 435, "bedlevel": 792.9000244140625, "branchid": "pipe_10_E267;pipe_10_E268", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_431_generated", "shape": null, "area": 0.64, "streetlevel": 795.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 795.9000244140625, "distance_right": 2.5355941251856743e-07, "index_right": 438, "nodeid": "1385937.883638_5859527.328235", "id": "1385937.883638_5859527.328235", "name": "manhole_431_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385937.883638251805678, 5859527.328234969638288 ] } }, +{ "type": "Feature", "properties": { "_index": 436, "bedlevel": 792.9000244140625, "branchid": "pipe_10_E268;pipe_10_E269", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_432_generated", "shape": null, "area": 0.64, "streetlevel": 795.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 795.9000244140625, "distance_right": 3.6358463847525687e-07, "index_right": 439, "nodeid": "1385940.515994_5859576.989168", "id": "1385940.515994_5859576.989168", "name": "manhole_432_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385940.515994266141206, 5859576.989168248139322 ] } }, +{ "type": "Feature", "properties": { "_index": 437, "bedlevel": 792.9000244140625, "branchid": "pipe_10_E269;pipe_10_E270", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_433_generated", "shape": null, "area": 0.64, "streetlevel": 795.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 795.9000244140625, "distance_right": 4.9116737648064597e-07, "index_right": 440, "nodeid": "1385950.701545_5859625.530177", "id": "1385950.701545_5859625.530177", "name": "manhole_433_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385950.701545101590455, 5859625.530176519416273 ] } }, +{ "type": "Feature", "properties": { "_index": 438, "bedlevel": 812.0, "branchid": "pipe_10_E270;pipe_10_E271", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_434_generated", "shape": null, "area": 0.64, "streetlevel": 815.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 815.0, "distance_right": 5.5124507418760386e-07, "index_right": 441, "nodeid": "1385970.467743_5859670.991299", "id": "1385970.467743_5859670.991299", "name": "manhole_434_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385970.467743494315073, 5859670.991298755630851 ] } }, +{ "type": "Feature", "properties": { "_index": 439, "bedlevel": 812.0, "branchid": "pipe_10_E271;pipe_10_E272", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_435_generated", "shape": null, "area": 0.64, "streetlevel": 815.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 815.0, "distance_right": 2.2592636056373782e-07, "index_right": 442, "nodeid": "1386011.983088_5859697.862917", "id": "1386011.983088_5859697.862917", "name": "manhole_435_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386011.983088220236823, 5859697.862916950136423 ] } }, +{ "type": "Feature", "properties": { "_index": 440, "bedlevel": 776.79998779296875, "branchid": "pipe_10_E272;pipe_10_E273", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_436_generated", "shape": null, "area": 0.64, "streetlevel": 779.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 779.79998779296875, "distance_right": 2.826630180046859e-07, "index_right": 443, "nodeid": "1386052.213596_5859727.119808", "id": "1386052.213596_5859727.119808", "name": "manhole_436_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386052.213596233632416, 5859727.119808158837259 ] } }, +{ "type": "Feature", "properties": { "_index": 441, "bedlevel": 777.79998779296875, "branchid": "pipe_10_E273;pipe_10_E274", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_437_generated", "shape": null, "area": 0.64, "streetlevel": 780.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 780.79998779296875, "distance_right": 1.7247219687616297e-07, "index_right": 444, "nodeid": "1386046.501013_5859771.612672", "id": "1386046.501013_5859771.612672", "name": "manhole_437_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386046.501012831227854, 5859771.612671964801848 ] } }, +{ "type": "Feature", "properties": { "_index": 442, "bedlevel": 777.79998779296875, "branchid": "pipe_10_E274;pipe_10_E275", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_438_generated", "shape": null, "area": 0.64, "streetlevel": 780.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 780.79998779296875, "distance_right": 2.6156737925919828e-07, "index_right": 445, "nodeid": "1386026.809696_5859816.873920", "id": "1386026.809696_5859816.873920", "name": "manhole_438_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386026.809695787727833, 5859816.873920152895153 ] } }, +{ "type": "Feature", "properties": { "_index": 443, "bedlevel": 777.79998779296875, "branchid": "pipe_10_E275;pipe_10_E276", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_439_generated", "shape": null, "area": 0.64, "streetlevel": 780.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 780.79998779296875, "distance_right": 3.7655071668317508e-07, "index_right": 446, "nodeid": "1386030.149607_5859866.379010", "id": "1386030.149607_5859866.379010", "name": "manhole_439_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386030.149607364553958, 5859866.379009906202555 ] } }, +{ "type": "Feature", "properties": { "_index": 444, "bedlevel": 763.29998779296875, "branchid": "pipe_10_E276", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_440_generated", "shape": null, "area": 0.64, "streetlevel": 766.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 766.29998779296875, "distance_right": 3.8584702415109949e-07, "index_right": 447, "nodeid": "1386045.250939_5859913.859036", "id": "1386045.250939_5859913.859036", "name": "manhole_440_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386045.250939248362556, 5859913.859036295674741 ] } }, +{ "type": "Feature", "properties": { "_index": 445, "bedlevel": 797.79998779296875, "branchid": "pipe_11_E0", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_441_generated", "shape": null, "area": 0.64, "streetlevel": 800.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 800.79998779296875, "distance_right": 4.7301652606593837e-07, "index_right": 448, "nodeid": "1384196.861816_5856829.880484", "id": "1384196.861816_5856829.880484", "name": "manhole_441_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384196.861816460033879, 5856829.88048410974443 ] } }, +{ "type": "Feature", "properties": { "_index": 445, "bedlevel": 797.79998779296875, "branchid": "pipe_11_E0;pipe_11_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_442_generated", "shape": null, "area": 0.64, "streetlevel": 800.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 800.79998779296875, "distance_right": 4.1916041075255855e-07, "index_right": 449, "nodeid": "1384235.225193_5856854.977666", "id": "1384235.225193_5856854.977666", "name": "manhole_442_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384235.22519311751239, 5856854.977665597572923 ] } }, +{ "type": "Feature", "properties": { "_index": 446, "bedlevel": 790.9000244140625, "branchid": "pipe_11_E1;pipe_11_E2", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_443_generated", "shape": null, "area": 0.64, "streetlevel": 793.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 793.9000244140625, "distance_right": 1.8064117134611431e-07, "index_right": 450, "nodeid": "1384263.450330_5856892.038371", "id": "1384263.450330_5856892.038371", "name": "manhole_443_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384263.450329831801355, 5856892.038370934315026 ] } }, +{ "type": "Feature", "properties": { "_index": 447, "bedlevel": 790.9000244140625, "branchid": "pipe_11_E2;pipe_11_E3", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_444_generated", "shape": null, "area": 0.64, "streetlevel": 793.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 793.9000244140625, "distance_right": 5.2895601992239946e-07, "index_right": 451, "nodeid": "1384291.675467_5856929.099076", "id": "1384291.675467_5856929.099076", "name": "manhole_444_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384291.675466545857489, 5856929.099076271057129 ] } }, +{ "type": "Feature", "properties": { "_index": 448, "bedlevel": 804.60003662109375, "branchid": "pipe_11_E3;pipe_11_E4", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_445_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 4.6972328747941346e-07, "index_right": 452, "nodeid": "1384319.900603_5856966.159782", "id": "1384319.900603_5856966.159782", "name": "manhole_445_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384319.900603260146454, 5856966.159781608730555 ] } }, +{ "type": "Feature", "properties": { "_index": 449, "bedlevel": 804.60003662109375, "branchid": "pipe_11_E4;pipe_11_E5", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_446_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 3.2505859644673266e-07, "index_right": 453, "nodeid": "1384347.205868_5857003.894511", "id": "1384347.205868_5857003.894511", "name": "manhole_446_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384347.205867683747783, 5857003.894510924816132 ] } }, +{ "type": "Feature", "properties": { "_index": 450, "bedlevel": 796.0, "branchid": "pipe_11_E5;pipe_11_E6", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_447_generated", "shape": null, "area": 0.64, "streetlevel": 799.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 799.0, "distance_right": 4.0063787966893061e-08, "index_right": 454, "nodeid": "1384380.322691_5857036.360282", "id": "1384380.322691_5857036.360282", "name": "manhole_447_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384380.322691001230851, 5857036.360282040201128 ] } }, +{ "type": "Feature", "properties": { "_index": 451, "bedlevel": 804.60003662109375, "branchid": "pipe_11_E6;pipe_11_E7", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_448_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 6.5217326255448256e-07, "index_right": 455, "nodeid": "1384415.156611_5857067.291694", "id": "1384415.156611_5857067.291694", "name": "manhole_448_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384415.156610523350537, 5857067.291694445535541 ] } }, +{ "type": "Feature", "properties": { "_index": 452, "bedlevel": 792.9000244140625, "branchid": "pipe_11_E7;pipe_11_E8", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_449_generated", "shape": null, "area": 0.64, "streetlevel": 795.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 795.9000244140625, "distance_right": 2.5437427121489189e-07, "index_right": 456, "nodeid": "1384449.343576_5857098.828100", "id": "1384449.343576_5857098.828100", "name": "manhole_449_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384449.343575850594789, 5857098.828100205399096 ] } }, +{ "type": "Feature", "properties": { "_index": 453, "bedlevel": 792.9000244140625, "branchid": "pipe_11_E8;pipe_11_E9", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_450_generated", "shape": null, "area": 0.64, "streetlevel": 795.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 795.9000244140625, "distance_right": 2.5635753496972149e-07, "index_right": 457, "nodeid": "1384470.004810_5857139.926174", "id": "1384470.004810_5857139.926174", "name": "manhole_450_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384470.004810179118067, 5857139.926174183376133 ] } }, +{ "type": "Feature", "properties": { "_index": 454, "bedlevel": 792.9000244140625, "branchid": "pipe_11_E9", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_451_generated", "shape": null, "area": 0.64, "streetlevel": 795.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 795.9000244140625, "distance_right": 2.3880128290434959e-07, "index_right": 458, "nodeid": "1384484.180762_5857184.301805", "id": "1384484.180762_5857184.301805", "name": "manhole_451_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384484.18076178082265, 5857184.301805094815791 ] } }, +{ "type": "Feature", "properties": { "_index": 455, "bedlevel": 804.60003662109375, "branchid": "pipe_12_E0", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_452_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 2.9575907640532436e-07, "index_right": 459, "nodeid": "1384289.065524_5856954.947841", "id": "1384289.065524_5856954.947841", "name": "manhole_452_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384289.06552429520525, 5856954.947841017507017 ] } }, +{ "type": "Feature", "properties": { "_index": 455, "bedlevel": 804.60003662109375, "branchid": "pipe_12_E0;pipe_12_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_453_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 4.147576493632742e-07, "index_right": 460, "nodeid": "1384305.049611_5856994.887349", "id": "1384305.049611_5856994.887349", "name": "manhole_453_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384305.049610810354352, 5856994.88734863139689 ] } }, +{ "type": "Feature", "properties": { "_index": 456, "bedlevel": 804.60003662109375, "branchid": "pipe_12_E1;pipe_12_E2", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_454_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 4.0680171125278462e-07, "index_right": 461, "nodeid": "1384321.033697_5857034.826856", "id": "1384321.033697_5857034.826856", "name": "manhole_454_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384321.033697325503454, 5857034.82685624435544 ] } }, +{ "type": "Feature", "properties": { "_index": 457, "bedlevel": 796.0, "branchid": "pipe_12_E2;pipe_12_E3", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_455_generated", "shape": null, "area": 0.64, "streetlevel": 799.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 799.0, "distance_right": 5.1416054878534695e-07, "index_right": 462, "nodeid": "1384347.445656_5857068.672039", "id": "1384347.445656_5857068.672039", "name": "manhole_455_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384347.445656489115208, 5857068.672038841992617 ] } }, +{ "type": "Feature", "properties": { "_index": 458, "bedlevel": 804.60003662109375, "branchid": "pipe_12_E3;pipe_12_E4", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_456_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 6.3615944847267436e-07, "index_right": 463, "nodeid": "1384374.130628_5857102.406952", "id": "1384374.130628_5857102.406952", "name": "manhole_456_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384374.130628447979689, 5857102.406951548531651 ] } }, +{ "type": "Feature", "properties": { "_index": 459, "bedlevel": 804.60003662109375, "branchid": "pipe_12_E4;pipe_12_E5", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_457_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 3.5938825885944809e-07, "index_right": 464, "nodeid": "1384399.587644_5857137.085412", "id": "1384399.587644_5857137.085412", "name": "manhole_457_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384399.587644136510789, 5857137.08541233278811 ] } }, +{ "type": "Feature", "properties": { "_index": 460, "bedlevel": 804.60003662109375, "branchid": "pipe_12_E5;pipe_12_E6", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_458_generated", "shape": null, "area": 0.64, "streetlevel": 807.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.60003662109375, "distance_right": 2.1058202778609514e-07, "index_right": 465, "nodeid": "1384425.044660_5857171.763873", "id": "1384425.044660_5857171.763873", "name": "manhole_458_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384425.04465982504189, 5857171.763873117044568 ] } }, +{ "type": "Feature", "properties": { "_index": 461, "bedlevel": 792.9000244140625, "branchid": "pipe_12_E6;pipe_15_E0;pipe_17_E0", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_459_generated", "shape": null, "area": 0.64, "streetlevel": 795.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 795.9000244140625, "distance_right": 1.0521498026447859e-07, "index_right": 466, "nodeid": "1384456.866521_5857200.577978", "id": "1384456.866521_5857200.577978", "name": "manhole_459_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384456.866520966170356, 5857200.577977900393307 ] } }, +{ "type": "Feature", "properties": { "_index": 462, "bedlevel": 792.9000244140625, "branchid": "pipe_15_E0", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_460_generated", "shape": null, "area": 0.64, "streetlevel": 795.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 795.9000244140625, "distance_right": 5.3722077541611869e-07, "index_right": 467, "nodeid": "1384480.774831_5857195.244455", "id": "1384480.774831_5857195.244455", "name": "manhole_460_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384480.774830641923472, 5857195.244455400854349 ] } }, +{ "type": "Feature", "properties": { "_index": 463, "bedlevel": 802.0, "branchid": "pipe_17_E0;pipe_18_E0;pipe_19_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_461_generated", "shape": null, "area": 0.64, "streetlevel": 805.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 805.0, "distance_right": 1.9196784202574641e-07, "index_right": 468, "nodeid": "1384478.871156_5857219.682923", "id": "1384478.871156_5857219.682923", "name": "manhole_461_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384478.871156033361331, 5857219.682923189364374 ] } }, +{ "type": "Feature", "properties": { "_index": 464, "bedlevel": 802.0, "branchid": "pipe_18_E0;pipe_19_E0", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_462_generated", "shape": null, "area": 0.64, "streetlevel": 805.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 805.0, "distance_right": 4.2284615434076742e-07, "index_right": 469, "nodeid": "1384493.329777_5857201.952338", "id": "1384493.329777_5857201.952338", "name": "manhole_462_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384493.329776774393395, 5857201.952337642200291 ] } }, +{ "type": "Feature", "properties": { "_index": 465, "bedlevel": 802.0, "branchid": "pipe_19_E0;pipe_19_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_463_generated", "shape": null, "area": 0.64, "streetlevel": 805.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 805.0, "distance_right": 2.1723785306021382e-07, "index_right": 470, "nodeid": "1384511.321100_5857246.008046", "id": "1384511.321100_5857246.008046", "name": "manhole_463_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384511.321100181667134, 5857246.008046119473875 ] } }, +{ "type": "Feature", "properties": { "_index": 467, "bedlevel": 802.0, "branchid": "pipe_20_E0", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_464_generated", "shape": null, "area": 0.64, "streetlevel": 805.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 805.0, "distance_right": 3.7745466738450301e-07, "index_right": 471, "nodeid": "1384512.484967_5857248.858029", "id": "1384512.484967_5857248.858029", "name": "manhole_464_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384512.484966830350459, 5857248.858029337599874 ] } }, +{ "type": "Feature", "properties": { "_index": 467, "bedlevel": 793.29998779296875, "branchid": "pipe_20_E0;pipe_20_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_465_generated", "shape": null, "area": 0.64, "streetlevel": 796.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 796.29998779296875, "distance_right": 2.9467429280942488e-07, "index_right": 472, "nodeid": "1384550.208547_5857281.609187", "id": "1384550.208547_5857281.609187", "name": "manhole_465_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384550.208547196350992, 5857281.609186780638993 ] } }, +{ "type": "Feature", "properties": { "_index": 468, "bedlevel": 793.29998779296875, "branchid": "pipe_20_E1;pipe_20_E2", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_466_generated", "shape": null, "area": 0.64, "streetlevel": 796.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 796.29998779296875, "distance_right": 4.9191202976319131e-07, "index_right": 473, "nodeid": "1384587.932128_5857314.360344", "id": "1384587.932128_5857314.360344", "name": "manhole_466_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384587.932127562351525, 5857314.360344224609435 ] } }, +{ "type": "Feature", "properties": { "_index": 469, "bedlevel": 806.10003662109375, "branchid": "pipe_20_E2;pipe_20_E3", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_467_generated", "shape": null, "area": 0.64, "streetlevel": 809.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 809.10003662109375, "distance_right": 3.5761089101492169e-07, "index_right": 474, "nodeid": "1384608.456867_5857358.785165", "id": "1384608.456867_5857358.785165", "name": "manhole_467_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384608.456866907887161, 5857358.785165345296264 ] } }, +{ "type": "Feature", "properties": { "_index": 470, "bedlevel": 806.10003662109375, "branchid": "pipe_20_E3;pipe_20_E4", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_468_generated", "shape": null, "area": 0.64, "streetlevel": 809.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 809.10003662109375, "distance_right": 3.4869916151305031e-07, "index_right": 475, "nodeid": "1384624.966164_5857405.935456", "id": "1384624.966164_5857405.935456", "name": "manhole_468_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384624.966163935838267, 5857405.935456342995167 ] } }, +{ "type": "Feature", "properties": { "_index": 471, "bedlevel": 791.29998779296875, "branchid": "pipe_20_E4;pipe_20_E5", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_469_generated", "shape": null, "area": 0.64, "streetlevel": 794.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 794.29998779296875, "distance_right": 5.3270430114269587e-07, "index_right": 476, "nodeid": "1384639.938245_5857453.586039", "id": "1384639.938245_5857453.586039", "name": "manhole_469_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384639.938245237572119, 5857453.586039477027953 ] } }, +{ "type": "Feature", "properties": { "_index": 472, "bedlevel": 809.4000244140625, "branchid": "pipe_20_E5;pipe_20_E6", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_470_generated", "shape": null, "area": 0.64, "streetlevel": 812.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 812.4000244140625, "distance_right": 4.9705781674062353e-07, "index_right": 477, "nodeid": "1384654.342376_5857501.421464", "id": "1384654.342376_5857501.421464", "name": "manhole_470_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384654.3423755497206, 5857501.421464210376143 ] } }, +{ "type": "Feature", "properties": { "_index": 473, "bedlevel": 809.4000244140625, "branchid": "pipe_20_E6;pipe_20_E7", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_471_generated", "shape": null, "area": 0.64, "streetlevel": 812.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 812.4000244140625, "distance_right": 2.7046393679534545e-07, "index_right": 478, "nodeid": "1384665.748858_5857550.055336", "id": "1384665.748858_5857550.055336", "name": "manhole_471_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384665.748858094681054, 5857550.055336253717542 ] } }, +{ "type": "Feature", "properties": { "_index": 474, "bedlevel": 809.4000244140625, "branchid": "pipe_20_E7;pipe_20_E8", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_472_generated", "shape": null, "area": 0.64, "streetlevel": 812.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 812.4000244140625, "distance_right": 4.1869249149785678e-07, "index_right": 479, "nodeid": "1384677.047727_5857598.717872", "id": "1384677.047727_5857598.717872", "name": "manhole_472_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384677.04772660904564, 5857598.717872150242329 ] } }, +{ "type": "Feature", "properties": { "_index": 475, "bedlevel": 815.9000244140625, "branchid": "pipe_20_E8;pipe_20_E9", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_473_generated", "shape": null, "area": 0.64, "streetlevel": 818.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 818.9000244140625, "distance_right": 1.315680624067599e-07, "index_right": 480, "nodeid": "1384688.346595_5857647.380408", "id": "1384688.346595_5857647.380408", "name": "manhole_473_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384688.346595123410225, 5857647.380408045835793 ] } }, +{ "type": "Feature", "properties": { "_index": 476, "bedlevel": 815.9000244140625, "branchid": "pipe_20_E9;pipe_20_E10", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_474_generated", "shape": null, "area": 0.64, "streetlevel": 818.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 818.9000244140625, "distance_right": 3.6700491044701186e-07, "index_right": 481, "nodeid": "1384699.645464_5857696.042944", "id": "1384699.645464_5857696.042944", "name": "manhole_474_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384699.64546363777481, 5857696.042943941429257 ] } }, +{ "type": "Feature", "properties": { "_index": 477, "bedlevel": 788.0, "branchid": "pipe_20_E10;pipe_20_E11", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_475_generated", "shape": null, "area": 0.64, "streetlevel": 791.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 791.0, "distance_right": 2.2220693550766025e-07, "index_right": 482, "nodeid": "1384710.944332_5857744.705480", "id": "1384710.944332_5857744.705480", "name": "manhole_475_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384710.944332152139395, 5857744.705479837954044 ] } }, +{ "type": "Feature", "properties": { "_index": 478, "bedlevel": 768.9000244140625, "branchid": "pipe_20_E11;pipe_20_E12", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_476_generated", "shape": null, "area": 0.64, "streetlevel": 771.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 771.9000244140625, "distance_right": 4.8028085976613379e-07, "index_right": 483, "nodeid": "1384726.848783_5857791.671308", "id": "1384726.848783_5857791.671308", "name": "manhole_476_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384726.848783193388954, 5857791.671307560056448 ] } }, +{ "type": "Feature", "properties": { "_index": 479, "bedlevel": 768.9000244140625, "branchid": "pipe_20_E12;pipe_20_E13", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_477_generated", "shape": null, "area": 0.64, "streetlevel": 771.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 771.9000244140625, "distance_right": 5.9588726492505702e-07, "index_right": 484, "nodeid": "1384753.929338_5857833.199649", "id": "1384753.929338_5857833.199649", "name": "manhole_477_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384753.929338480113074, 5857833.199649352580309 ] } }, +{ "type": "Feature", "properties": { "_index": 480, "bedlevel": 768.9000244140625, "branchid": "pipe_20_E13;pipe_20_E14", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_478_generated", "shape": null, "area": 0.64, "streetlevel": 771.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 771.9000244140625, "distance_right": 3.5161620977039942e-07, "index_right": 485, "nodeid": "1384783.627482_5857873.006575", "id": "1384783.627482_5857873.006575", "name": "manhole_478_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384783.627482200739905, 5857873.006575288251042 ] } }, +{ "type": "Feature", "properties": { "_index": 481, "bedlevel": 788.0, "branchid": "pipe_20_E14;pipe_20_E15", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_479_generated", "shape": null, "area": 0.64, "streetlevel": 791.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 791.0, "distance_right": 3.7131283277773026e-07, "index_right": 486, "nodeid": "1384795.018453_5857920.637507", "id": "1384795.018453_5857920.637507", "name": "manhole_479_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384795.018452654592693, 5857920.637507135979831 ] } }, +{ "type": "Feature", "properties": { "_index": 482, "bedlevel": 788.0, "branchid": "pipe_20_E15;pipe_20_E16", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_480_generated", "shape": null, "area": 0.64, "streetlevel": 791.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 791.0, "distance_right": 3.6017576108266254e-07, "index_right": 487, "nodeid": "1384785.075932_5857969.445633", "id": "1384785.075932_5857969.445633", "name": "manhole_480_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384785.075932276435196, 5857969.445633230730891 ] } }, +{ "type": "Feature", "properties": { "_index": 483, "bedlevel": 817.10003662109375, "branchid": "pipe_20_E16;pipe_20_E17", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_481_generated", "shape": null, "area": 0.64, "streetlevel": 820.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 820.10003662109375, "distance_right": 3.2088624364960761e-07, "index_right": 488, "nodeid": "1384771.479073_5858017.516750", "id": "1384771.479073_5858017.516750", "name": "manhole_481_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384771.479073295136914, 5858017.516749874688685 ] } }, +{ "type": "Feature", "properties": { "_index": 484, "bedlevel": 817.10003662109375, "branchid": "pipe_20_E17;pipe_20_E18", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_482_generated", "shape": null, "area": 0.64, "streetlevel": 820.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 820.10003662109375, "distance_right": 4.4953182233117254e-07, "index_right": 489, "nodeid": "1384763.325190_5858066.675425", "id": "1384763.325190_5858066.675425", "name": "manhole_482_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384763.32518996251747, 5858066.675425447523594 ] } }, +{ "type": "Feature", "properties": { "_index": 485, "bedlevel": 817.10003662109375, "branchid": "pipe_20_E18;pipe_20_E19", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_483_generated", "shape": null, "area": 0.64, "streetlevel": 820.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 820.10003662109375, "distance_right": 5.3880955032763759e-07, "index_right": 490, "nodeid": "1384757.405407_5858116.280496", "id": "1384757.405407_5858116.280496", "name": "manhole_483_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384757.405406558187678, 5858116.280495692044497 ] } }, +{ "type": "Feature", "properties": { "_index": 486, "bedlevel": 844.0, "branchid": "pipe_20_E19;pipe_20_E20", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_484_generated", "shape": null, "area": 0.64, "streetlevel": 847.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 847.0, "distance_right": 5.3637227265526465e-07, "index_right": 491, "nodeid": "1384746.211964_5858164.956997", "id": "1384746.211964_5858164.956997", "name": "manhole_484_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384746.211964494548738, 5858164.956996791996062 ] } }, +{ "type": "Feature", "properties": { "_index": 487, "bedlevel": 844.0, "branchid": "pipe_20_E20;pipe_20_E21", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_485_generated", "shape": null, "area": 0.64, "streetlevel": 847.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 847.0, "distance_right": 4.5977538296708937e-07, "index_right": 492, "nodeid": "1384738.028055_5858213.862444", "id": "1384738.028055_5858213.862444", "name": "manhole_485_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384738.028054837835953, 5858213.862443570047617 ] } }, +{ "type": "Feature", "properties": { "_index": 488, "bedlevel": 844.0, "branchid": "pipe_20_E21;pipe_20_E22", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_486_generated", "shape": null, "area": 0.64, "streetlevel": 847.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 847.0, "distance_right": 1.3906988183523212e-07, "index_right": 493, "nodeid": "1384756.479259_5858259.218586", "id": "1384756.479259_5858259.218586", "name": "manhole_486_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384756.479259133106098, 5858259.218586039729416 ] } }, +{ "type": "Feature", "properties": { "_index": 489, "bedlevel": 830.20001220703125, "branchid": "pipe_20_E22;pipe_20_E23", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_487_generated", "shape": null, "area": 0.64, "streetlevel": 833.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 833.20001220703125, "distance_right": 4.957432448534482e-07, "index_right": 494, "nodeid": "1384792.653981_5858293.253396", "id": "1384792.653981_5858293.253396", "name": "manhole_487_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384792.653981153853238, 5858293.25339647103101 ] } }, +{ "type": "Feature", "properties": { "_index": 490, "bedlevel": 759.29998779296875, "branchid": "pipe_20_E23;pipe_20_E24", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_488_generated", "shape": null, "area": 0.64, "streetlevel": 762.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.29998779296875, "distance_right": 3.4494981559446402e-07, "index_right": 495, "nodeid": "1384839.146884_5858310.949097", "id": "1384839.146884_5858310.949097", "name": "manhole_488_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384839.146884107263759, 5858310.949097327888012 ] } }, +{ "type": "Feature", "properties": { "_index": 491, "bedlevel": 759.29998779296875, "branchid": "pipe_20_E24;pipe_20_E25", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_489_generated", "shape": null, "area": 0.64, "streetlevel": 762.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.29998779296875, "distance_right": 4.1482822303052493e-07, "index_right": 496, "nodeid": "1384888.517510_5858307.535864", "id": "1384888.517510_5858307.535864", "name": "manhole_489_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384888.517509665805846, 5858307.535864246077836 ] } }, +{ "type": "Feature", "properties": { "_index": 492, "bedlevel": 748.0, "branchid": "pipe_20_E25;pipe_20_E26", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_490_generated", "shape": null, "area": 0.64, "streetlevel": 751.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 751.0, "distance_right": 1.9615342642219019e-07, "index_right": 497, "nodeid": "1384936.622763_5858294.068231", "id": "1384936.622763_5858294.068231", "name": "manhole_490_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384936.622762819286436, 5858294.068231076002121 ] } }, +{ "type": "Feature", "properties": { "_index": 493, "bedlevel": 748.0, "branchid": "pipe_20_E26;pipe_20_E27", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_491_generated", "shape": null, "area": 0.64, "streetlevel": 751.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 751.0, "distance_right": 5.3404041479262363e-07, "index_right": 498, "nodeid": "1384984.637113_5858280.272530", "id": "1384984.637113_5858280.272530", "name": "manhole_491_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384984.637113286415115, 5858280.272530450485647 ] } }, +{ "type": "Feature", "properties": { "_index": 494, "bedlevel": 740.20001220703125, "branchid": "pipe_20_E27;pipe_20_E28", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_492_generated", "shape": null, "area": 0.64, "streetlevel": 743.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 743.20001220703125, "distance_right": 4.4808866815921511e-07, "index_right": 499, "nodeid": "1385032.633651_5858266.414711", "id": "1385032.633651_5858266.414711", "name": "manhole_492_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385032.633651287527755, 5858266.414710656739771 ] } }, +{ "type": "Feature", "properties": { "_index": 495, "bedlevel": 740.20001220703125, "branchid": "pipe_20_E28;pipe_20_E29", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_493_generated", "shape": null, "area": 0.64, "streetlevel": 743.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 743.20001220703125, "distance_right": 4.5997725205119854e-07, "index_right": 500, "nodeid": "1385081.886840_5858258.136645", "id": "1385081.886840_5858258.136645", "name": "manhole_493_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385081.886840383987874, 5858258.136644747108221 ] } }, +{ "type": "Feature", "properties": { "_index": 496, "bedlevel": 744.60003662109375, "branchid": "pipe_20_E29;pipe_20_E30", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_494_generated", "shape": null, "area": 0.64, "streetlevel": 747.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 747.60003662109375, "distance_right": 5.1289583885473558e-07, "index_right": 501, "nodeid": "1385131.310464_5858263.211211", "id": "1385131.310464_5858263.211211", "name": "manhole_494_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385131.310463621048257, 5858263.211211345158517 ] } }, +{ "type": "Feature", "properties": { "_index": 497, "bedlevel": 753.79998779296875, "branchid": "pipe_20_E30;pipe_20_E31", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_495_generated", "shape": null, "area": 0.64, "streetlevel": 756.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 756.79998779296875, "distance_right": 1.466862620517437e-07, "index_right": 502, "nodeid": "1385177.729395_5858281.168494", "id": "1385177.729395_5858281.168494", "name": "manhole_495_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385177.729395114118233, 5858281.168494092300534 ] } }, +{ "type": "Feature", "properties": { "_index": 498, "bedlevel": 755.9000244140625, "branchid": "pipe_20_E31;pipe_20_E32", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_496_generated", "shape": null, "area": 0.64, "streetlevel": 758.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 758.9000244140625, "distance_right": 3.6395302459551237e-07, "index_right": 503, "nodeid": "1385219.956519_5858307.842426", "id": "1385219.956519_5858307.842426", "name": "manhole_496_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385219.95651927171275, 5858307.84242575801909 ] } }, +{ "type": "Feature", "properties": { "_index": 499, "bedlevel": 755.9000244140625, "branchid": "pipe_20_E32;pipe_20_E33", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_497_generated", "shape": null, "area": 0.64, "streetlevel": 758.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 758.9000244140625, "distance_right": 1.8879808927425897e-07, "index_right": 504, "nodeid": "1385261.864507_5858335.034840", "id": "1385261.864507_5858335.034840", "name": "manhole_497_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385261.864506913116202, 5858335.034840167500079 ] } }, +{ "type": "Feature", "properties": { "_index": 500, "bedlevel": 753.29998779296875, "branchid": "pipe_20_E33;pipe_20_E34", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_498_generated", "shape": null, "area": 0.64, "streetlevel": 756.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 756.29998779296875, "distance_right": 5.419301661765223e-07, "index_right": 505, "nodeid": "1385305.658712_5858358.964501", "id": "1385305.658712_5858358.964501", "name": "manhole_498_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385305.658712412696332, 5858358.964500648900867 ] } }, +{ "type": "Feature", "properties": { "_index": 501, "bedlevel": 753.29998779296875, "branchid": "pipe_20_E34;pipe_20_E35", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_499_generated", "shape": null, "area": 0.64, "streetlevel": 756.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 756.29998779296875, "distance_right": 1.8543977824422103e-07, "index_right": 506, "nodeid": "1385350.136276_5858381.712098", "id": "1385350.136276_5858381.712098", "name": "manhole_499_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385350.136275847908109, 5858381.712097893469036 ] } }, +{ "type": "Feature", "properties": { "_index": 502, "bedlevel": 747.79998779296875, "branchid": "pipe_20_E35;pipe_20_E36", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_500_generated", "shape": null, "area": 0.64, "streetlevel": 750.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 750.79998779296875, "distance_right": 3.5987401233780288e-07, "index_right": 507, "nodeid": "1385394.617425_5858404.452682", "id": "1385394.617425_5858404.452682", "name": "manhole_500_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385394.617425152566284, 5858404.452682325616479 ] } }, +{ "type": "Feature", "properties": { "_index": 503, "bedlevel": 757.20001220703125, "branchid": "pipe_20_E36;pipe_20_E37", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_501_generated", "shape": null, "area": 0.64, "streetlevel": 760.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 760.20001220703125, "distance_right": 4.601393315218742e-07, "index_right": 508, "nodeid": "1385439.245916_5858426.901899", "id": "1385439.245916_5858426.901899", "name": "manhole_501_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385439.245915542822331, 5858426.901898948475718 ] } }, +{ "type": "Feature", "properties": { "_index": 504, "bedlevel": 751.29998779296875, "branchid": "pipe_20_E37;pipe_20_E38", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_502_generated", "shape": null, "area": 0.64, "streetlevel": 754.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 754.29998779296875, "distance_right": 2.101491005489345e-07, "index_right": 509, "nodeid": "1385483.926140_5858449.248809", "id": "1385483.926140_5858449.248809", "name": "manhole_502_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385483.926139793125913, 5858449.248809035867453 ] } }, +{ "type": "Feature", "properties": { "_index": 505, "bedlevel": 751.29998779296875, "branchid": "pipe_20_E38;pipe_20_E39", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_503_generated", "shape": null, "area": 0.64, "streetlevel": 754.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 754.29998779296875, "distance_right": 1.7103720699768628e-07, "index_right": 510, "nodeid": "1385525.860647_5858475.863234", "id": "1385525.860647_5858475.863234", "name": "manhole_503_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385525.860647091642022, 5858475.8632338559255 ] } }, +{ "type": "Feature", "properties": { "_index": 506, "bedlevel": 751.29998779296875, "branchid": "pipe_20_E39;pipe_20_E40", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_504_generated", "shape": null, "area": 0.64, "streetlevel": 754.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 754.29998779296875, "distance_right": 4.4366280841908402e-07, "index_right": 511, "nodeid": "1385553.357332_5858517.404888", "id": "1385553.357332_5858517.404888", "name": "manhole_504_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385553.357332118786871, 5858517.404887572862208 ] } }, +{ "type": "Feature", "properties": { "_index": 507, "bedlevel": 748.70001220703125, "branchid": "pipe_20_E40;pipe_20_E41", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_505_generated", "shape": null, "area": 0.64, "streetlevel": 751.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 751.70001220703125, "distance_right": 3.4367514486766495e-07, "index_right": 512, "nodeid": "1385579.617479_5858559.686365", "id": "1385579.617479_5858559.686365", "name": "manhole_505_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385579.617479301057756, 5858559.686364834196866 ] } }, +{ "type": "Feature", "properties": { "_index": 508, "bedlevel": 748.70001220703125, "branchid": "pipe_20_E41;pipe_20_E42", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_506_generated", "shape": null, "area": 0.64, "streetlevel": 751.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 751.70001220703125, "distance_right": 2.5610704050949026e-07, "index_right": 513, "nodeid": "1385621.905694_5858585.068031", "id": "1385621.905694_5858585.068031", "name": "manhole_506_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385621.905693766893819, 5858585.068030893802643 ] } }, +{ "type": "Feature", "properties": { "_index": 509, "bedlevel": 747.9000244140625, "branchid": "pipe_20_E42;pipe_20_E43", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_507_generated", "shape": null, "area": 0.64, "streetlevel": 750.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 750.9000244140625, "distance_right": 3.6119177667836709e-07, "index_right": 514, "nodeid": "1385664.027274_5858611.351027", "id": "1385664.027274_5858611.351027", "name": "manhole_507_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385664.027273919200525, 5858611.351026647724211 ] } }, +{ "type": "Feature", "properties": { "_index": 510, "bedlevel": 747.9000244140625, "branchid": "pipe_20_E43;pipe_20_E44", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_508_generated", "shape": null, "area": 0.64, "streetlevel": 750.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 750.9000244140625, "distance_right": 4.2503991281748145e-07, "index_right": 515, "nodeid": "1385700.387206_5858645.507955", "id": "1385700.387206_5858645.507955", "name": "manhole_508_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385700.387205619364977, 5858645.507954810746014 ] } }, +{ "type": "Feature", "properties": { "_index": 511, "bedlevel": 747.9000244140625, "branchid": "pipe_20_E44;pipe_20_E45", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_509_generated", "shape": null, "area": 0.64, "streetlevel": 750.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 750.9000244140625, "distance_right": 4.0335649518180225e-07, "index_right": 516, "nodeid": "1385734.601841_5858681.909405", "id": "1385734.601841_5858681.909405", "name": "manhole_509_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385734.601841112133116, 5858681.909404612146318 ] } }, +{ "type": "Feature", "properties": { "_index": 512, "bedlevel": 752.79998779296875, "branchid": "pipe_20_E45;pipe_20_E46", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_510_generated", "shape": null, "area": 0.64, "streetlevel": 755.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 755.79998779296875, "distance_right": 5.7125618808521589e-07, "index_right": 517, "nodeid": "1385768.816477_5858718.310854", "id": "1385768.816477_5858718.310854", "name": "manhole_510_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385768.816476604901254, 5858718.310854412615299 ] } }, +{ "type": "Feature", "properties": { "_index": 513, "bedlevel": 752.79998779296875, "branchid": "pipe_20_E46;pipe_20_E47", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_511_generated", "shape": null, "area": 0.64, "streetlevel": 755.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 755.79998779296875, "distance_right": 9.4215891635551309e-08, "index_right": 518, "nodeid": "1385802.200312_5858755.447310", "id": "1385802.200312_5858755.447310", "name": "manhole_511_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385802.200311921536922, 5858755.447309947572649 ] } }, +{ "type": "Feature", "properties": { "_index": 514, "bedlevel": 752.79998779296875, "branchid": "pipe_20_E47", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_512_generated", "shape": null, "area": 0.64, "streetlevel": 755.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 755.79998779296875, "distance_right": 4.9733410300668418e-07, "index_right": 519, "nodeid": "1385834.159462_5858793.844179", "id": "1385834.159462_5858793.844179", "name": "manhole_512_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385834.15946239954792, 5858793.844178703613579 ] } }, +{ "type": "Feature", "properties": { "_index": 515, "bedlevel": 753.29998779296875, "branchid": "pipe_21_E0", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_513_generated", "shape": null, "area": 0.64, "streetlevel": 756.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 756.29998779296875, "distance_right": 3.3313663649888272e-07, "index_right": 520, "nodeid": "1385352.471788_5858398.702550", "id": "1385352.471788_5858398.702550", "name": "manhole_513_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385352.471788094611838, 5858398.70255031902343 ] } }, +{ "type": "Feature", "properties": { "_index": 515, "bedlevel": 762.0, "branchid": "pipe_21_E0;pipe_21_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_514_generated", "shape": null, "area": 0.64, "streetlevel": 765.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 765.0, "distance_right": 5.4077632442523464e-07, "index_right": 521, "nodeid": "1385323.609450_5858430.098599", "id": "1385323.609450_5858430.098599", "name": "manhole_514_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385323.609449510695413, 5858430.098599229939282 ] } }, +{ "type": "Feature", "properties": { "_index": 516, "bedlevel": 762.0, "branchid": "pipe_21_E1;pipe_21_E2", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_515_generated", "shape": null, "area": 0.64, "streetlevel": 765.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 765.0, "distance_right": 2.9393603149665491e-07, "index_right": 522, "nodeid": "1385286.388776_5858419.306092", "id": "1385286.388776_5858419.306092", "name": "manhole_515_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385286.388775944709778, 5858419.306091710925102 ] } }, +{ "type": "Feature", "properties": { "_index": 517, "bedlevel": 755.9000244140625, "branchid": "pipe_21_E2;pipe_21_E3", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_516_generated", "shape": null, "area": 0.64, "streetlevel": 758.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 758.9000244140625, "distance_right": 4.2516335479223613e-07, "index_right": 523, "nodeid": "1385252.458743_5858394.201655", "id": "1385252.458743_5858394.201655", "name": "manhole_516_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385252.458742934046313, 5858394.201654580421746 ] } }, +{ "type": "Feature", "properties": { "_index": 518, "bedlevel": 755.9000244140625, "branchid": "pipe_21_E3;pipe_21_E4", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_517_generated", "shape": null, "area": 0.64, "streetlevel": 758.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 758.9000244140625, "distance_right": 5.5811889877153229e-07, "index_right": 524, "nodeid": "1385217.536378_5858369.723605", "id": "1385217.536378_5858369.723605", "name": "manhole_517_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385217.536378393415362, 5858369.72360460460186 ] } }, +{ "type": "Feature", "properties": { "_index": 519, "bedlevel": 753.79998779296875, "branchid": "pipe_21_E4", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_518_generated", "shape": null, "area": 0.64, "streetlevel": 756.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 756.79998779296875, "distance_right": 5.341153742051576e-07, "index_right": 525, "nodeid": "1385177.877520_5858363.975667", "id": "1385177.877520_5858363.975667", "name": "manhole_518_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385177.877519500209019, 5858363.975667187944055 ] } }, +{ "type": "Feature", "properties": { "_index": 520, "bedlevel": 810.60003662109375, "branchid": "pipe_23_E0", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_519_generated", "shape": null, "area": 0.64, "streetlevel": 813.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 813.60003662109375, "distance_right": 3.7932856782999725e-07, "index_right": 526, "nodeid": "1384748.107252_5858475.465394", "id": "1384748.107252_5858475.465394", "name": "manhole_519_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384748.107251951703802, 5858475.46539437584579 ] } }, +{ "type": "Feature", "properties": { "_index": 520, "bedlevel": 810.60003662109375, "branchid": "pipe_23_E0;pipe_23_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_520_generated", "shape": null, "area": 0.64, "streetlevel": 813.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 813.60003662109375, "distance_right": 1.5235470245872061e-07, "index_right": 527, "nodeid": "1384773.662756_5858482.028829", "id": "1384773.662756_5858482.028829", "name": "manhole_520_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384773.662756133358926, 5858482.028828926384449 ] } }, +{ "type": "Feature", "properties": { "_index": 521, "bedlevel": 810.60003662109375, "branchid": "pipe_23_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_521_generated", "shape": null, "area": 0.64, "streetlevel": 813.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 813.60003662109375, "distance_right": 5.7240456036556167e-07, "index_right": 528, "nodeid": "1384799.218260_5858488.592263", "id": "1384799.218260_5858488.592263", "name": "manhole_521_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1384799.21826031524688, 5858488.592263477854431 ] } }, +{ "type": "Feature", "properties": { "_index": 522, "bedlevel": 759.9000244140625, "branchid": "pipe_24_E0;pipe_26_E0;pipe_29_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_522_generated", "shape": null, "area": 0.64, "streetlevel": 762.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.9000244140625, "distance_right": 4.1723277328328253e-07, "index_right": 529, "nodeid": "1385831.554475_5858837.476551", "id": "1385831.554475_5858837.476551", "name": "manhole_522_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385831.554474999429658, 5858837.476550582796335 ] } }, +{ "type": "Feature", "properties": { "_index": 522, "bedlevel": 748.4000244140625, "branchid": "pipe_24_E0;pipe_24_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_523_generated", "shape": null, "area": 0.64, "streetlevel": 751.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 751.4000244140625, "distance_right": 3.5562508610116324e-07, "index_right": 530, "nodeid": "1385834.933234_5858795.367518", "id": "1385834.933234_5858795.367518", "name": "manhole_523_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385834.933234154479578, 5858795.367517679929733 ] } }, +{ "type": "Feature", "properties": { "_index": 523, "bedlevel": 756.70001220703125, "branchid": "pipe_24_E1;pipe_26_E0", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_524_generated", "shape": null, "area": 0.64, "streetlevel": 759.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 759.70001220703125, "distance_right": 1.6097894538102849e-07, "index_right": 531, "nodeid": "1385855.640896_5858836.135080", "id": "1385855.640896_5858836.135080", "name": "manhole_524_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385855.640895856311545, 5858836.135079927742481 ] } }, +{ "type": "Feature", "properties": { "_index": 524, "bedlevel": 783.79998779296875, "branchid": "pipe_25_E0", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_525_generated", "shape": null, "area": 0.64, "streetlevel": 786.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 786.79998779296875, "distance_right": 4.9875171671174047e-07, "index_right": 532, "nodeid": "1385425.871742_5858809.522039", "id": "1385425.871742_5858809.522039", "name": "manhole_525_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385425.871741503709927, 5858809.522038951516151 ] } }, +{ "type": "Feature", "properties": { "_index": 524, "bedlevel": 788.20001220703125, "branchid": "pipe_25_E0;pipe_25_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_526_generated", "shape": null, "area": 0.64, "streetlevel": 791.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 791.20001220703125, "distance_right": 5.7550611101994379e-07, "index_right": 533, "nodeid": "1385446.216240_5858844.397749", "id": "1385446.216240_5858844.397749", "name": "manhole_526_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385446.216239683330059, 5858844.397748519666493 ] } }, +{ "type": "Feature", "properties": { "_index": 525, "bedlevel": 788.20001220703125, "branchid": "pipe_25_E1;pipe_25_E2", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_527_generated", "shape": null, "area": 0.64, "streetlevel": 791.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 791.20001220703125, "distance_right": 2.8135076174496163e-07, "index_right": 534, "nodeid": "1385453.998638_5858886.437654", "id": "1385453.998638_5858886.437654", "name": "manhole_527_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385453.998638280900195, 5858886.437654017470777 ] } }, +{ "type": "Feature", "properties": { "_index": 526, "bedlevel": 780.0, "branchid": "pipe_25_E2", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_528_generated", "shape": null, "area": 0.64, "streetlevel": 783.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 783.0, "distance_right": 4.913263386404469e-07, "index_right": 535, "nodeid": "1385472.218053_5858925.273073", "id": "1385472.218053_5858925.273073", "name": "manhole_528_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385472.218053022632375, 5858925.273072509095073 ] } }, +{ "type": "Feature", "properties": { "_index": 528, "bedlevel": 756.70001220703125, "branchid": "pipe_29_E0", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_529_generated", "shape": null, "area": 0.64, "streetlevel": 759.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 759.70001220703125, "distance_right": 2.0428258687376185e-07, "index_right": 536, "nodeid": "1385861.372514_5858893.832569", "id": "1385861.372514_5858893.832569", "name": "manhole_529_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385861.372513797832653, 5858893.832569030113518 ] } }, +{ "type": "Feature", "properties": { "_index": 528, "bedlevel": 756.70001220703125, "branchid": "pipe_29_E0;pipe_29_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_530_generated", "shape": null, "area": 0.64, "streetlevel": 759.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 759.70001220703125, "distance_right": 1.9678914319064008e-07, "index_right": 537, "nodeid": "1385844.630084_5858865.848266", "id": "1385844.630084_5858865.848266", "name": "manhole_530_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1385844.630084188189358, 5858865.848266057670116 ] } }, +{ "type": "Feature", "properties": { "_index": 530, "bedlevel": 766.4000244140625, "branchid": "pipe_30_E0", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_531_generated", "shape": null, "area": 0.64, "streetlevel": 769.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 769.4000244140625, "distance_right": 1.0826199317136784e-07, "index_right": 538, "nodeid": "1387137.223009_5858981.723107", "id": "1387137.223009_5858981.723107", "name": "manhole_531_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387137.22300889948383, 5858981.723106959834695 ] } }, +{ "type": "Feature", "properties": { "_index": 530, "bedlevel": 766.4000244140625, "branchid": "pipe_30_E0;pipe_30_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_532_generated", "shape": null, "area": 0.64, "streetlevel": 769.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 769.4000244140625, "distance_right": 3.686684848268439e-07, "index_right": 539, "nodeid": "1387148.048593_5859026.366798", "id": "1387148.048593_5859026.366798", "name": "manhole_532_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387148.04859330272302, 5859026.366797789931297 ] } }, +{ "type": "Feature", "properties": { "_index": 531, "bedlevel": 759.60003662109375, "branchid": "pipe_30_E1;pipe_30_E2", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_533_generated", "shape": null, "area": 0.64, "streetlevel": 762.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.60003662109375, "distance_right": 5.7761078259871499e-07, "index_right": 540, "nodeid": "1387119.959376_5859056.934599", "id": "1387119.959376_5859056.934599", "name": "manhole_533_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387119.95937648974359, 5859056.934598693624139 ] } }, +{ "type": "Feature", "properties": { "_index": 532, "bedlevel": 759.60003662109375, "branchid": "pipe_30_E2;pipe_30_E3", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_534_generated", "shape": null, "area": 0.64, "streetlevel": 762.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.60003662109375, "distance_right": 4.8820694205349016e-07, "index_right": 541, "nodeid": "1387074.832296_5859065.301006", "id": "1387074.832296_5859065.301006", "name": "manhole_534_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387074.832296247361228, 5859065.30100557859987 ] } }, +{ "type": "Feature", "properties": { "_index": 533, "bedlevel": 752.79998779296875, "branchid": "pipe_30_E3;pipe_30_E4", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_535_generated", "shape": null, "area": 0.64, "streetlevel": 755.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 755.79998779296875, "distance_right": 3.374577181130728e-07, "index_right": 542, "nodeid": "1387030.356415_5859076.861371", "id": "1387030.356415_5859076.861371", "name": "manhole_535_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387030.356415221933275, 5859076.86137125454843 ] } }, +{ "type": "Feature", "properties": { "_index": 534, "bedlevel": 769.4000244140625, "branchid": "pipe_30_E4;pipe_30_E5", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_536_generated", "shape": null, "area": 0.64, "streetlevel": 772.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 772.4000244140625, "distance_right": 5.6152650214475575e-07, "index_right": 543, "nodeid": "1386986.427999_5859090.309648", "id": "1386986.427999_5859090.309648", "name": "manhole_536_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386986.427998587489128, 5859090.309648380614817 ] } }, +{ "type": "Feature", "properties": { "_index": 535, "bedlevel": 758.60003662109375, "branchid": "pipe_30_E5;pipe_30_E6", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_537_generated", "shape": null, "area": 0.64, "streetlevel": 761.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 761.60003662109375, "distance_right": 5.4995130325451761e-07, "index_right": 544, "nodeid": "1386945.966695_5859111.788387", "id": "1386945.966695_5859111.788387", "name": "manhole_537_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386945.966695382725447, 5859111.788386604748666 ] } }, +{ "type": "Feature", "properties": { "_index": 536, "bedlevel": 758.60003662109375, "branchid": "pipe_30_E6;pipe_30_E7", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_538_generated", "shape": null, "area": 0.64, "streetlevel": 761.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 761.60003662109375, "distance_right": 4.9633513749728012e-07, "index_right": 545, "nodeid": "1386905.771024_5859134.105929", "id": "1386905.771024_5859134.105929", "name": "manhole_538_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386905.77102447184734, 5859134.105928846634924 ] } }, +{ "type": "Feature", "properties": { "_index": 537, "bedlevel": 758.60003662109375, "branchid": "pipe_30_E7;pipe_32_E0;pipe_33_E0", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_539_generated", "shape": null, "area": 0.64, "streetlevel": 761.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 761.60003662109375, "distance_right": 2.7520069926497903e-07, "index_right": 546, "nodeid": "1386871.537448_5859162.609671", "id": "1386871.537448_5859162.609671", "name": "manhole_539_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386871.537448140559718, 5859162.609670763835311 ] } }, +{ "type": "Feature", "properties": { "_index": 538, "bedlevel": 758.60003662109375, "branchid": "pipe_32_E0;pipe_32_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_540_generated", "shape": null, "area": 0.64, "streetlevel": 761.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 761.60003662109375, "distance_right": 4.8588826730380931e-07, "index_right": 547, "nodeid": "1386921.106019_5859163.103915", "id": "1386921.106019_5859163.103915", "name": "manhole_540_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386921.106019288301468, 5859163.103915391489863 ] } }, +{ "type": "Feature", "properties": { "_index": 539, "bedlevel": 769.4000244140625, "branchid": "pipe_32_E1;pipe_32_E2", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_541_generated", "shape": null, "area": 0.64, "streetlevel": 772.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 772.4000244140625, "distance_right": 4.9582240878676894e-07, "index_right": 548, "nodeid": "1386970.627896_5859161.624509", "id": "1386970.627896_5859161.624509", "name": "manhole_541_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386970.627896018791944, 5859161.624508504755795 ] } }, +{ "type": "Feature", "properties": { "_index": 540, "bedlevel": 769.4000244140625, "branchid": "pipe_32_E2;pipe_32_E3", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_542_generated", "shape": null, "area": 0.64, "streetlevel": 772.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 772.4000244140625, "distance_right": 5.5451950297642449e-07, "index_right": 549, "nodeid": "1387019.993600_5859157.412991", "id": "1387019.993600_5859157.412991", "name": "manhole_542_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387019.993600395740941, 5859157.412991388700902 ] } }, +{ "type": "Feature", "properties": { "_index": 541, "bedlevel": 778.10003662109375, "branchid": "pipe_32_E3;pipe_32_E4", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_543_generated", "shape": null, "area": 0.64, "streetlevel": 781.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 781.10003662109375, "distance_right": 3.1035547522737893e-07, "index_right": 550, "nodeid": "1387069.191226_5859151.340004", "id": "1387069.191226_5859151.340004", "name": "manhole_543_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387069.191225855611265, 5859151.340004274621606 ] } }, +{ "type": "Feature", "properties": { "_index": 542, "bedlevel": 778.10003662109375, "branchid": "pipe_32_E4;pipe_32_E5", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_544_generated", "shape": null, "area": 0.64, "streetlevel": 781.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 781.10003662109375, "distance_right": 2.6808181379243751e-07, "index_right": 551, "nodeid": "1387118.547864_5859146.828393", "id": "1387118.547864_5859146.828393", "name": "manhole_544_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387118.547863835236058, 5859146.828392788767815 ] } }, +{ "type": "Feature", "properties": { "_index": 543, "bedlevel": 783.4000244140625, "branchid": "pipe_32_E5;pipe_32_E6", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_545_generated", "shape": null, "area": 0.64, "streetlevel": 786.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 786.4000244140625, "distance_right": 4.3713920793115639e-07, "index_right": 552, "nodeid": "1387167.916039_5859151.025294", "id": "1387167.916039_5859151.025294", "name": "manhole_545_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387167.916038708761334, 5859151.025294326245785 ] } }, +{ "type": "Feature", "properties": { "_index": 544, "bedlevel": 783.4000244140625, "branchid": "pipe_32_E6;pipe_32_E7", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_546_generated", "shape": null, "area": 0.64, "streetlevel": 786.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 786.4000244140625, "distance_right": 2.5205839433754474e-07, "index_right": 553, "nodeid": "1387217.282605_5859155.523035", "id": "1387217.282605_5859155.523035", "name": "manhole_546_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387217.282604865729809, 5859155.523034786805511 ] } }, +{ "type": "Feature", "properties": { "_index": 545, "bedlevel": 784.60003662109375, "branchid": "pipe_32_E7;pipe_32_E8", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_547_generated", "shape": null, "area": 0.64, "streetlevel": 787.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 787.60003662109375, "distance_right": 2.4966567906009152e-07, "index_right": 554, "nodeid": "1387266.649171_5859160.020775", "id": "1387266.649171_5859160.020775", "name": "manhole_547_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387266.649171022465453, 5859160.020775248296559 ] } }, +{ "type": "Feature", "properties": { "_index": 546, "bedlevel": 784.60003662109375, "branchid": "pipe_32_E8;pipe_32_E9", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_548_generated", "shape": null, "area": 0.64, "streetlevel": 787.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 787.60003662109375, "distance_right": 2.4506572779662508e-07, "index_right": 555, "nodeid": "1387315.831188_5859165.716173", "id": "1387315.831188_5859165.716173", "name": "manhole_548_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387315.831188223091885, 5859165.716172898188233 ] } }, +{ "type": "Feature", "properties": { "_index": 547, "bedlevel": 787.4000244140625, "branchid": "pipe_32_E9;pipe_32_E10", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_549_generated", "shape": null, "area": 0.64, "streetlevel": 790.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 790.4000244140625, "distance_right": 3.8513770845044176e-07, "index_right": 556, "nodeid": "1387364.261765_5859176.288154", "id": "1387364.261765_5859176.288154", "name": "manhole_549_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387364.261764668161049, 5859176.288154195994139 ] } }, +{ "type": "Feature", "properties": { "_index": 548, "bedlevel": 787.4000244140625, "branchid": "pipe_32_E10;pipe_32_E11", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_550_generated", "shape": null, "area": 0.64, "streetlevel": 790.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 790.4000244140625, "distance_right": 3.3210008430605365e-08, "index_right": 557, "nodeid": "1387411.186260_5859192.118345", "id": "1387411.186260_5859192.118345", "name": "manhole_550_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387411.186259990092367, 5859192.118345031514764 ] } }, +{ "type": "Feature", "properties": { "_index": 549, "bedlevel": 786.10003662109375, "branchid": "pipe_32_E11;pipe_32_E12", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_551_generated", "shape": null, "area": 0.64, "streetlevel": 789.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 789.10003662109375, "distance_right": 4.7365879545282216e-07, "index_right": 558, "nodeid": "1387455.544593_5859213.906052", "id": "1387455.544593_5859213.906052", "name": "manhole_551_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387455.544592748628929, 5859213.906051598489285 ] } }, +{ "type": "Feature", "properties": { "_index": 550, "bedlevel": 814.20001220703125, "branchid": "pipe_32_E12;pipe_32_E13", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_552_generated", "shape": null, "area": 0.64, "streetlevel": 817.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 817.20001220703125, "distance_right": 3.9529020951305247e-07, "index_right": 559, "nodeid": "1387490.610425_5859248.941349", "id": "1387490.610425_5859248.941349", "name": "manhole_552_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387490.610425172373652, 5859248.94134864397347 ] } }, +{ "type": "Feature", "properties": { "_index": 551, "bedlevel": 815.20001220703125, "branchid": "pipe_32_E13;pipe_32_E14", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_553_generated", "shape": null, "area": 0.64, "streetlevel": 818.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 818.20001220703125, "distance_right": 5.4228296261137134e-07, "index_right": 560, "nodeid": "1387525.979066_5859283.669168", "id": "1387525.979066_5859283.669168", "name": "manhole_553_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387525.979065561201423, 5859283.669168318621814 ] } }, +{ "type": "Feature", "properties": { "_index": 552, "bedlevel": 815.20001220703125, "branchid": "pipe_32_E14;pipe_32_E15", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_554_generated", "shape": null, "area": 0.64, "streetlevel": 818.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 818.20001220703125, "distance_right": 3.0182548578634254e-07, "index_right": 561, "nodeid": "1387563.532417_5859316.027063", "id": "1387563.532417_5859316.027063", "name": "manhole_554_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387563.532416822388768, 5859316.0270627560094 ] } }, +{ "type": "Feature", "properties": { "_index": 553, "bedlevel": 799.79998779296875, "branchid": "pipe_32_E15;pipe_32_E16", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_555_generated", "shape": null, "area": 0.64, "streetlevel": 802.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 802.79998779296875, "distance_right": 2.1107147677987274e-07, "index_right": 562, "nodeid": "1387601.085768_5859348.384957", "id": "1387601.085768_5859348.384957", "name": "manhole_555_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387601.085768083808944, 5859348.384957193396986 ] } }, +{ "type": "Feature", "properties": { "_index": 554, "bedlevel": 834.70001220703125, "branchid": "pipe_32_E16;pipe_32_E17", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_556_generated", "shape": null, "area": 0.64, "streetlevel": 837.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 837.70001220703125, "distance_right": 5.052127214258991e-07, "index_right": 563, "nodeid": "1387638.639119_5859380.742852", "id": "1387638.639119_5859380.742852", "name": "manhole_556_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387638.639119345229119, 5859380.742851630784571 ] } }, +{ "type": "Feature", "properties": { "_index": 555, "bedlevel": 834.70001220703125, "branchid": "pipe_32_E17;pipe_32_E18", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_557_generated", "shape": null, "area": 0.64, "streetlevel": 837.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 837.70001220703125, "distance_right": 3.9931398916583509e-07, "index_right": 564, "nodeid": "1387676.192471_5859413.100746", "id": "1387676.192471_5859413.100746", "name": "manhole_557_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387676.192470606416464, 5859413.100746068172157 ] } }, +{ "type": "Feature", "properties": { "_index": 556, "bedlevel": 825.79998779296875, "branchid": "pipe_32_E18;pipe_32_E19", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_558_generated", "shape": null, "area": 0.64, "streetlevel": 828.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 828.79998779296875, "distance_right": 5.1280958514562511e-07, "index_right": 565, "nodeid": "1387713.745822_5859445.458641", "id": "1387713.745822_5859445.458641", "name": "manhole_558_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387713.745821867836639, 5859445.45864050462842 ] } }, +{ "type": "Feature", "properties": { "_index": 557, "bedlevel": 825.79998779296875, "branchid": "pipe_32_E19;pipe_32_E20", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_559_generated", "shape": null, "area": 0.64, "streetlevel": 828.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 828.79998779296875, "distance_right": 4.9162563938563157e-07, "index_right": 566, "nodeid": "1387750.394378_5859478.825171", "id": "1387750.394378_5859478.825171", "name": "manhole_559_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387750.394377880264074, 5859478.825171477161348 ] } }, +{ "type": "Feature", "properties": { "_index": 558, "bedlevel": 851.29998779296875, "branchid": "pipe_32_E20;pipe_32_E21", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_560_generated", "shape": null, "area": 0.64, "streetlevel": 854.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 854.29998779296875, "distance_right": 2.2099050354582448e-07, "index_right": 567, "nodeid": "1387786.626277_5859512.656178", "id": "1387786.626277_5859512.656178", "name": "manhole_560_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387786.626276910537854, 5859512.656178202480078 ] } }, +{ "type": "Feature", "properties": { "_index": 559, "bedlevel": 851.29998779296875, "branchid": "pipe_32_E21;pipe_32_E22", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_561_generated", "shape": null, "area": 0.64, "streetlevel": 854.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 854.29998779296875, "distance_right": 9.454214361901851e-08, "index_right": 568, "nodeid": "1387822.858176_5859546.487185", "id": "1387822.858176_5859546.487185", "name": "manhole_561_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387822.858175940578803, 5859546.487184926867485 ] } }, +{ "type": "Feature", "properties": { "_index": 560, "bedlevel": 851.29998779296875, "branchid": "pipe_32_E22;pipe_32_E23", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_562_generated", "shape": null, "area": 0.64, "streetlevel": 854.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 854.29998779296875, "distance_right": 2.3615409729123986e-07, "index_right": 569, "nodeid": "1387850.662340_5859586.980696", "id": "1387850.662340_5859586.980696", "name": "manhole_562_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387850.662340233800933, 5859586.980695966631174 ] } }, +{ "type": "Feature", "properties": { "_index": 561, "bedlevel": 888.20001220703125, "branchid": "pipe_32_E23;pipe_32_E24", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_563_generated", "shape": null, "area": 0.64, "streetlevel": 891.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 891.20001220703125, "distance_right": 3.4181092772059008e-07, "index_right": 570, "nodeid": "1387868.193222_5859633.330901", "id": "1387868.193222_5859633.330901", "name": "manhole_563_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387868.193221996771172, 5859633.330900657922029 ] } }, +{ "type": "Feature", "properties": { "_index": 562, "bedlevel": 873.20001220703125, "branchid": "pipe_32_E24;pipe_32_E25", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_564_generated", "shape": null, "area": 0.64, "streetlevel": 876.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 876.20001220703125, "distance_right": 2.546826698671963e-07, "index_right": 571, "nodeid": "1387885.535610_5859679.769345", "id": "1387885.535610_5859679.769345", "name": "manhole_564_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387885.535610173596069, 5859679.769344814121723 ] } }, +{ "type": "Feature", "properties": { "_index": 563, "bedlevel": 873.20001220703125, "branchid": "pipe_32_E25;pipe_32_E26", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_565_generated", "shape": null, "area": 0.64, "streetlevel": 876.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 876.20001220703125, "distance_right": 5.6690489460937244e-07, "index_right": 572, "nodeid": "1387902.854486_5859726.216553", "id": "1387902.854486_5859726.216553", "name": "manhole_565_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387902.854485532967374, 5859726.216552678495646 ] } }, +{ "type": "Feature", "properties": { "_index": 564, "bedlevel": 895.29998779296875, "branchid": "pipe_32_E26;pipe_32_E27", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_566_generated", "shape": null, "area": 0.64, "streetlevel": 898.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 898.29998779296875, "distance_right": 6.0131442630219361e-07, "index_right": 573, "nodeid": "1387920.137465_5859772.677140", "id": "1387920.137465_5859772.677140", "name": "manhole_566_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387920.137465380365029, 5859772.67713953461498 ] } }, +{ "type": "Feature", "properties": { "_index": 565, "bedlevel": 895.29998779296875, "branchid": "pipe_32_E27;pipe_32_E28", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_567_generated", "shape": null, "area": 0.64, "streetlevel": 898.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 898.29998779296875, "distance_right": 4.516857479022367e-07, "index_right": 574, "nodeid": "1387937.420445_5859819.137726", "id": "1387937.420445_5859819.137726", "name": "manhole_567_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387937.420445227529854, 5859819.137726389802992 ] } }, +{ "type": "Feature", "properties": { "_index": 566, "bedlevel": 895.29998779296875, "branchid": "pipe_32_E28;pipe_32_E29", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_568_generated", "shape": null, "area": 0.64, "streetlevel": 898.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 898.29998779296875, "distance_right": 3.8531895841013795e-07, "index_right": 575, "nodeid": "1387948.863531_5859867.082766", "id": "1387948.863531_5859867.082766", "name": "manhole_568_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387948.863530882401392, 5859867.082766367122531 ] } }, +{ "type": "Feature", "properties": { "_index": 567, "bedlevel": 915.5, "branchid": "pipe_32_E29;pipe_32_E30", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_569_generated", "shape": null, "area": 0.64, "streetlevel": 918.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 918.5, "distance_right": 7.5942774747301615e-08, "index_right": 576, "nodeid": "1387950.013254_5859916.565450", "id": "1387950.013254_5859916.565450", "name": "manhole_569_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387950.013254075078294, 5859916.565449987538159 ] } }, +{ "type": "Feature", "properties": { "_index": 568, "bedlevel": 915.5, "branchid": "pipe_32_E30;pipe_32_E31", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_570_generated", "shape": null, "area": 0.64, "streetlevel": 918.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 918.5, "distance_right": 4.0775453204516037e-07, "index_right": 577, "nodeid": "1387947.430783_5859966.047936", "id": "1387947.430783_5859966.047936", "name": "manhole_570_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387947.430782878771424, 5859966.047936389222741 ] } }, +{ "type": "Feature", "properties": { "_index": 569, "bedlevel": 915.5, "branchid": "pipe_32_E31;pipe_32_E32", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_571_generated", "shape": null, "area": 0.64, "streetlevel": 918.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 918.5, "distance_right": 2.8747268719335361e-07, "index_right": 578, "nodeid": "1387943.997958_5860015.499966", "id": "1387943.997958_5860015.499966", "name": "manhole_571_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387943.997958281077445, 5860015.499966060742736 ] } }, +{ "type": "Feature", "properties": { "_index": 570, "bedlevel": 945.60003662109375, "branchid": "pipe_32_E32;pipe_32_E33", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_572_generated", "shape": null, "area": 0.64, "streetlevel": 948.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 948.60003662109375, "distance_right": 4.1395802122621752e-07, "index_right": 579, "nodeid": "1387940.565134_5860064.951996", "id": "1387940.565134_5860064.951996", "name": "manhole_572_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387940.565133683150634, 5860064.951995733194053 ] } }, +{ "type": "Feature", "properties": { "_index": 571, "bedlevel": 945.60003662109375, "branchid": "pipe_32_E33;pipe_32_E34", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_573_generated", "shape": null, "area": 0.64, "streetlevel": 948.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 948.60003662109375, "distance_right": 5.9329268490131064e-07, "index_right": 580, "nodeid": "1387945.371778_5860113.959105", "id": "1387945.371778_5860113.959105", "name": "manhole_573_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387945.371777657186612, 5860113.959104515612125 ] } }, +{ "type": "Feature", "properties": { "_index": 572, "bedlevel": 945.60003662109375, "branchid": "pipe_32_E34;pipe_32_E35", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_574_generated", "shape": null, "area": 0.64, "streetlevel": 948.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 948.60003662109375, "distance_right": 7.0201338766485011e-07, "index_right": 581, "nodeid": "1387964.117816_5860159.736532", "id": "1387964.117816_5860159.736532", "name": "manhole_574_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387964.117816498270258, 5860159.736532494425774 ] } }, +{ "type": "Feature", "properties": { "_index": 573, "bedlevel": 937.5, "branchid": "pipe_32_E35;pipe_32_E36", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_575_generated", "shape": null, "area": 0.64, "streetlevel": 940.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 940.5, "distance_right": 2.2971831659588874e-07, "index_right": 582, "nodeid": "1387984.093858_5860205.104421", "id": "1387984.093858_5860205.104421", "name": "manhole_575_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387984.093857799191028, 5860205.104420888237655 ] } }, +{ "type": "Feature", "properties": { "_index": 574, "bedlevel": 937.5, "branchid": "pipe_32_E36;pipe_32_E37", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_576_generated", "shape": null, "area": 0.64, "streetlevel": 940.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 940.5, "distance_right": 2.9934678285276023e-07, "index_right": 583, "nodeid": "1388004.069899_5860250.472309", "id": "1388004.069899_5860250.472309", "name": "manhole_576_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388004.069899099878967, 5860250.472309282049537 ] } }, +{ "type": "Feature", "properties": { "_index": 575, "bedlevel": 937.5, "branchid": "pipe_32_E37;pipe_32_E38", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_577_generated", "shape": null, "area": 0.64, "streetlevel": 940.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 940.5, "distance_right": 3.961540705670488e-07, "index_right": 584, "nodeid": "1388027.686926_5860293.896034", "id": "1388027.686926_5860293.896034", "name": "manhole_577_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388027.68692572391592, 5860293.896034284494817 ] } }, +{ "type": "Feature", "properties": { "_index": 576, "bedlevel": 968.70001220703125, "branchid": "pipe_32_E38;pipe_32_E39", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_578_generated", "shape": null, "area": 0.64, "streetlevel": 971.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 971.70001220703125, "distance_right": 4.1731728271541691e-07, "index_right": 585, "nodeid": "1388060.096316_5860331.348726", "id": "1388060.096316_5860331.348726", "name": "manhole_578_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388060.096315970877185, 5860331.348726416006684 ] } }, +{ "type": "Feature", "properties": { "_index": 577, "bedlevel": 932.5, "branchid": "pipe_32_E39;pipe_32_E40", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_579_generated", "shape": null, "area": 0.64, "streetlevel": 935.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 935.5, "distance_right": 3.2982661108630707e-07, "index_right": 586, "nodeid": "1388092.967689_5860368.453448", "id": "1388092.967689_5860368.453448", "name": "manhole_579_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388092.967688721138984, 5860368.453448176383972 ] } }, +{ "type": "Feature", "properties": { "_index": 578, "bedlevel": 932.5, "branchid": "pipe_32_E40;pipe_32_E41", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_580_generated", "shape": null, "area": 0.64, "streetlevel": 935.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 935.5, "distance_right": 2.9233183103705959e-07, "index_right": 587, "nodeid": "1388119.020827_5860410.510252", "id": "1388119.020827_5860410.510252", "name": "manhole_580_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388119.020827289205045, 5860410.510251956991851 ] } }, +{ "type": "Feature", "properties": { "_index": 579, "bedlevel": 946.9000244140625, "branchid": "pipe_32_E41;pipe_32_E42", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_581_generated", "shape": null, "area": 0.64, "streetlevel": 949.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 949.9000244140625, "distance_right": 2.622579606939989e-07, "index_right": 588, "nodeid": "1388143.407623_5860453.667774", "id": "1388143.407623_5860453.667774", "name": "manhole_581_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388143.407622833969072, 5860453.667774203233421 ] } }, +{ "type": "Feature", "properties": { "_index": 580, "bedlevel": 921.60003662109375, "branchid": "pipe_32_E42;pipe_32_E43", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_582_generated", "shape": null, "area": 0.64, "streetlevel": 924.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 924.60003662109375, "distance_right": 5.8808766619105842e-07, "index_right": 589, "nodeid": "1388167.794418_5860496.825296", "id": "1388167.794418_5860496.825296", "name": "manhole_582_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388167.794418378733099, 5860496.82529644947499 ] } }, +{ "type": "Feature", "properties": { "_index": 581, "bedlevel": 921.60003662109375, "branchid": "pipe_32_E43;pipe_32_E44", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_583_generated", "shape": null, "area": 0.64, "streetlevel": 924.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 924.60003662109375, "distance_right": 4.62331076853642e-07, "index_right": 590, "nodeid": "1388187.411865_5860542.097805", "id": "1388187.411865_5860542.097805", "name": "manhole_583_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388187.41186453984119, 5860542.097804954275489 ] } }, +{ "type": "Feature", "properties": { "_index": 582, "bedlevel": 939.4000244140625, "branchid": "pipe_32_E44;pipe_32_E45", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_584_generated", "shape": null, "area": 0.64, "streetlevel": 942.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 942.4000244140625, "distance_right": 4.0785502827304659e-07, "index_right": 591, "nodeid": "1388193.385166_5860591.251542", "id": "1388193.385166_5860591.251542", "name": "manhole_584_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388193.385166377527639, 5860591.251542154699564 ] } }, +{ "type": "Feature", "properties": { "_index": 583, "bedlevel": 939.4000244140625, "branchid": "pipe_32_E45;pipe_32_E46", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_585_generated", "shape": null, "area": 0.64, "streetlevel": 942.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 942.4000244140625, "distance_right": 5.4027566975976428e-07, "index_right": 592, "nodeid": "1388198.812296_5860640.524595", "id": "1388198.812296_5860640.524595", "name": "manhole_585_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388198.812296225922182, 5860640.524595490656793 ] } }, +{ "type": "Feature", "properties": { "_index": 584, "bedlevel": 939.4000244140625, "branchid": "pipe_32_E46;pipe_32_E47", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_586_generated", "shape": null, "area": 0.64, "streetlevel": 942.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 942.4000244140625, "distance_right": 1.8942515075575965e-07, "index_right": 593, "nodeid": "1388204.239426_5860689.797649", "id": "1388204.239426_5860689.797649", "name": "manhole_586_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388204.239426074549556, 5860689.7976488256827 ] } }, +{ "type": "Feature", "properties": { "_index": 585, "bedlevel": 952.0, "branchid": "pipe_32_E47;pipe_32_E48", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_587_generated", "shape": null, "area": 0.64, "streetlevel": 955.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 955.0, "distance_right": 4.7329980236488121e-07, "index_right": 594, "nodeid": "1388184.484932_5860730.700382", "id": "1388184.484932_5860730.700382", "name": "manhole_587_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388184.484932377934456, 5860730.700381714850664 ] } }, +{ "type": "Feature", "properties": { "_index": 586, "bedlevel": 952.0, "branchid": "pipe_32_E48;pipe_32_E49", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_588_generated", "shape": null, "area": 0.64, "streetlevel": 955.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 955.0, "distance_right": 3.139676122188116e-07, "index_right": 595, "nodeid": "1388159.550175_5860759.392760", "id": "1388159.550175_5860759.392760", "name": "manhole_588_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388159.550175313837826, 5860759.392759991809726 ] } }, +{ "type": "Feature", "properties": { "_index": 587, "bedlevel": 952.0, "branchid": "pipe_32_E49;pipe_32_E50", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_589_generated", "shape": null, "area": 0.64, "streetlevel": 955.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 955.0, "distance_right": 4.7230733375433857e-07, "index_right": 596, "nodeid": "1388171.988545_5860807.377909", "id": "1388171.988545_5860807.377909", "name": "manhole_589_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388171.988544700434431, 5860807.377908634953201 ] } }, +{ "type": "Feature", "properties": { "_index": 588, "bedlevel": 952.0, "branchid": "pipe_32_E50;pipe_32_E51", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_590_generated", "shape": null, "area": 0.64, "streetlevel": 955.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 955.0, "distance_right": 3.1729683108018581e-07, "index_right": 597, "nodeid": "1388215.013826_5860825.214943", "id": "1388215.013826_5860825.214943", "name": "manhole_590_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388215.013825689908117, 5860825.214942933060229 ] } }, +{ "type": "Feature", "properties": { "_index": 589, "bedlevel": 938.10003662109375, "branchid": "pipe_32_E51;pipe_32_E52", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_591_generated", "shape": null, "area": 0.64, "streetlevel": 941.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 941.10003662109375, "distance_right": 4.5798497811612042e-07, "index_right": 598, "nodeid": "1388264.397385_5860829.298033", "id": "1388264.397385_5860829.298033", "name": "manhole_591_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388264.397385431453586, 5860829.298032846301794 ] } }, +{ "type": "Feature", "properties": { "_index": 590, "bedlevel": 938.10003662109375, "branchid": "pipe_32_E52;pipe_32_E53", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_592_generated", "shape": null, "area": 0.64, "streetlevel": 941.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 941.10003662109375, "distance_right": 1.4876766767999893e-07, "index_right": 599, "nodeid": "1388313.062300_5860837.304879", "id": "1388313.062300_5860837.304879", "name": "manhole_592_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388313.062299854354933, 5860837.304878970608115 ] } }, +{ "type": "Feature", "properties": { "_index": 591, "bedlevel": 934.5, "branchid": "pipe_32_E53;pipe_32_E54", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_593_generated", "shape": null, "area": 0.64, "streetlevel": 937.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 937.5, "distance_right": 4.0248930382691132e-07, "index_right": 600, "nodeid": "1388360.993895_5860849.948046", "id": "1388360.993895_5860849.948046", "name": "manhole_593_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388360.993895401246846, 5860849.948045967146754 ] } }, +{ "type": "Feature", "properties": { "_index": 592, "bedlevel": 934.5, "branchid": "pipe_32_E54;pipe_32_E55", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_594_generated", "shape": null, "area": 0.64, "streetlevel": 937.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 937.5, "distance_right": 6.3027904613646236e-08, "index_right": 601, "nodeid": "1388408.925491_5860862.591213", "id": "1388408.925491_5860862.591213", "name": "manhole_594_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388408.925490947905928, 5860862.591212964616716 ] } }, +{ "type": "Feature", "properties": { "_index": 593, "bedlevel": 934.60003662109375, "branchid": "pipe_32_E55;pipe_32_E56", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_595_generated", "shape": null, "area": 0.64, "streetlevel": 937.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 937.60003662109375, "distance_right": 3.2074430373907896e-07, "index_right": 602, "nodeid": "1388458.220990_5860866.957202", "id": "1388458.220990_5860866.957202", "name": "manhole_595_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388458.220990223577246, 5860866.957201769575477 ] } }, +{ "type": "Feature", "properties": { "_index": 594, "bedlevel": 934.60003662109375, "branchid": "pipe_32_E56;pipe_32_E57", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_596_generated", "shape": null, "area": 0.64, "streetlevel": 937.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 937.60003662109375, "distance_right": 9.4677368422183038e-08, "index_right": 603, "nodeid": "1388507.336333_5860873.218385", "id": "1388507.336333_5860873.218385", "name": "manhole_596_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388507.336333080893382, 5860873.218384950421751 ] } }, +{ "type": "Feature", "properties": { "_index": 595, "bedlevel": 938.20001220703125, "branchid": "pipe_32_E57;pipe_32_E58", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_597_generated", "shape": null, "area": 0.64, "streetlevel": 941.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 941.20001220703125, "distance_right": 1.7964449623010729e-07, "index_right": 604, "nodeid": "1388556.215695_5860881.470384", "id": "1388556.215695_5860881.470384", "name": "manhole_597_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388556.215695114107803, 5860881.470384138636291 ] } }, +{ "type": "Feature", "properties": { "_index": 596, "bedlevel": 938.20001220703125, "branchid": "pipe_32_E58;pipe_32_E59", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_598_generated", "shape": null, "area": 0.64, "streetlevel": 941.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 941.20001220703125, "distance_right": 1.6011233671525675e-07, "index_right": 605, "nodeid": "1388604.556662_5860892.361969", "id": "1388604.556662_5860892.361969", "name": "manhole_598_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388604.556662159739062, 5860892.361969010904431 ] } }, +{ "type": "Feature", "properties": { "_index": 597, "bedlevel": 940.10003662109375, "branchid": "pipe_32_E59;pipe_32_E60", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_599_generated", "shape": null, "area": 0.64, "streetlevel": 943.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 943.10003662109375, "distance_right": 3.6964422062035383e-07, "index_right": 606, "nodeid": "1388653.599403_5860897.157898", "id": "1388653.599403_5860897.157898", "name": "manhole_599_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388653.59940263046883, 5860897.15789801068604 ] } }, +{ "type": "Feature", "properties": { "_index": 598, "bedlevel": 940.10003662109375, "branchid": "pipe_32_E60;pipe_32_E61", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_600_generated", "shape": null, "area": 0.64, "streetlevel": 943.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 943.10003662109375, "distance_right": 2.0861885525397415e-07, "index_right": 607, "nodeid": "1388700.080393_5860881.090511", "id": "1388700.080393_5860881.090511", "name": "manhole_600_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388700.080393208190799, 5860881.090511013753712 ] } }, +{ "type": "Feature", "properties": { "_index": 599, "bedlevel": 943.10003662109375, "branchid": "pipe_32_E61;pipe_32_E62", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_601_generated", "shape": null, "area": 0.64, "streetlevel": 946.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 946.10003662109375, "distance_right": 3.9818478577045887e-07, "index_right": 608, "nodeid": "1388732.687004_5860844.794781", "id": "1388732.687004_5860844.794781", "name": "manhole_601_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388732.687003659084439, 5860844.794781206175685 ] } }, +{ "type": "Feature", "properties": { "_index": 600, "bedlevel": 949.60003662109375, "branchid": "pipe_32_E62;pipe_32_E63", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_602_generated", "shape": null, "area": 0.64, "streetlevel": 952.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 952.60003662109375, "distance_right": 4.6036082438879739e-07, "index_right": 609, "nodeid": "1388755.953327_5860801.023036", "id": "1388755.953327_5860801.023036", "name": "manhole_602_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388755.953327334951609, 5860801.023035684600472 ] } }, +{ "type": "Feature", "properties": { "_index": 601, "bedlevel": 949.60003662109375, "branchid": "pipe_32_E63;pipe_32_E64", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_603_generated", "shape": null, "area": 0.64, "streetlevel": 952.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 952.60003662109375, "distance_right": 3.1337664014648673e-07, "index_right": 610, "nodeid": "1388778.233699_5860756.840240", "id": "1388778.233699_5860756.840240", "name": "manhole_603_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388778.23369869007729, 5860756.84024004638195 ] } }, +{ "type": "Feature", "properties": { "_index": 602, "bedlevel": 949.60003662109375, "branchid": "pipe_32_E64;pipe_32_E65", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_604_generated", "shape": null, "area": 0.64, "streetlevel": 952.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 952.60003662109375, "distance_right": 4.2335884748059321e-07, "index_right": 611, "nodeid": "1388792.950794_5860709.504264", "id": "1388792.950794_5860709.504264", "name": "manhole_604_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388792.950793598080054, 5860709.504263866692781 ] } }, +{ "type": "Feature", "properties": { "_index": 603, "bedlevel": 950.79998779296875, "branchid": "pipe_32_E65;pipe_32_E66", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_605_generated", "shape": null, "area": 0.64, "streetlevel": 953.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 953.79998779296875, "distance_right": 5.8393628355043254e-07, "index_right": 612, "nodeid": "1388807.667889_5860662.168288", "id": "1388807.667889_5860662.168288", "name": "manhole_605_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388807.667888506315649, 5860662.168287687934935 ] } }, +{ "type": "Feature", "properties": { "_index": 604, "bedlevel": 950.79998779296875, "branchid": "pipe_32_E66;pipe_32_E67", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_606_generated", "shape": null, "area": 0.64, "streetlevel": 953.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 953.79998779296875, "distance_right": 4.2307634411646621e-07, "index_right": 613, "nodeid": "1388819.224423_5860613.968191", "id": "1388819.224423_5860613.968191", "name": "manhole_606_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388819.224422588944435, 5860613.968191100284457 ] } }, +{ "type": "Feature", "properties": { "_index": 605, "bedlevel": 952.70001220703125, "branchid": "pipe_32_E67;pipe_32_E68", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_607_generated", "shape": null, "area": 0.64, "streetlevel": 955.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 955.70001220703125, "distance_right": 3.2847915211358398e-07, "index_right": 614, "nodeid": "1388830.638255_5860565.729079", "id": "1388830.638255_5860565.729079", "name": "manhole_607_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388830.63825476472266, 5860565.72907877061516 ] } }, +{ "type": "Feature", "properties": { "_index": 606, "bedlevel": 952.70001220703125, "branchid": "pipe_32_E68;pipe_32_E69", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_608_generated", "shape": null, "area": 0.64, "streetlevel": 955.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 955.70001220703125, "distance_right": 4.4360684295309176e-07, "index_right": 615, "nodeid": "1388842.052087_5860517.489966", "id": "1388842.052087_5860517.489966", "name": "manhole_608_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388842.052086940500885, 5860517.489966440014541 ] } }, +{ "type": "Feature", "properties": { "_index": 607, "bedlevel": 952.70001220703125, "branchid": "pipe_32_E69;pipe_32_E70", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_609_generated", "shape": null, "area": 0.64, "streetlevel": 955.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 955.70001220703125, "distance_right": 2.9630697691100381e-07, "index_right": 616, "nodeid": "1388862.776240_5860472.578981", "id": "1388862.776240_5860472.578981", "name": "manhole_609_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388862.77624000934884, 5860472.578981296159327 ] } }, +{ "type": "Feature", "properties": { "_index": 608, "bedlevel": 961.70001220703125, "branchid": "pipe_32_E70;pipe_32_E71", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_610_generated", "shape": null, "area": 0.64, "streetlevel": 964.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 964.70001220703125, "distance_right": 4.1085287726334795e-07, "index_right": 617, "nodeid": "1388884.529400_5860428.035884", "id": "1388884.529400_5860428.035884", "name": "manhole_610_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388884.529400010826066, 5860428.03588358964771 ] } }, +{ "type": "Feature", "properties": { "_index": 609, "bedlevel": 948.29998779296875, "branchid": "pipe_32_E71;pipe_32_E72", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_611_generated", "shape": null, "area": 0.64, "streetlevel": 951.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 951.29998779296875, "distance_right": 1.9786385917489472e-07, "index_right": 618, "nodeid": "1388906.282638_5860383.492824", "id": "1388906.282638_5860383.492824", "name": "manhole_611_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388906.282637836178765, 5860383.492823889479041 ] } }, +{ "type": "Feature", "properties": { "_index": 610, "bedlevel": 948.29998779296875, "branchid": "pipe_32_E72;pipe_32_E73", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_612_generated", "shape": null, "area": 0.64, "streetlevel": 951.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 951.29998779296875, "distance_right": 4.5358570654776362e-07, "index_right": 619, "nodeid": "1388933.946376_5860342.419800", "id": "1388933.946376_5860342.419800", "name": "manhole_612_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388933.946375871310011, 5860342.419800435192883 ] } }, +{ "type": "Feature", "properties": { "_index": 611, "bedlevel": 948.29998779296875, "branchid": "pipe_32_E73", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_613_generated", "shape": null, "area": 0.64, "streetlevel": 951.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 951.29998779296875, "distance_right": 4.6166295054686266e-07, "index_right": 620, "nodeid": "1388962.240716_5860301.717001", "id": "1388962.240716_5860301.717001", "name": "manhole_613_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388962.240715913940221, 5860301.717001453973353 ] } }, +{ "type": "Feature", "properties": { "_index": 612, "bedlevel": 749.29998779296875, "branchid": "pipe_33_E0;pipe_33_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_614_generated", "shape": null, "area": 0.64, "streetlevel": 752.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 752.29998779296875, "distance_right": 2.1054701440998384e-07, "index_right": 621, "nodeid": "1386825.198348_5859175.156894", "id": "1386825.198348_5859175.156894", "name": "manhole_614_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386825.19834817154333, 5859175.156894122250378 ] } }, +{ "type": "Feature", "properties": { "_index": 613, "bedlevel": 749.29998779296875, "branchid": "pipe_33_E1;pipe_33_E2", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_615_generated", "shape": null, "area": 0.64, "streetlevel": 752.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 752.29998779296875, "distance_right": 4.0506811183797461e-07, "index_right": 622, "nodeid": "1386779.333999_5859189.448422", "id": "1386779.333999_5859189.448422", "name": "manhole_615_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386779.333999397465959, 5859189.44842192158103 ] } }, +{ "type": "Feature", "properties": { "_index": 614, "bedlevel": 735.0, "branchid": "pipe_33_E2;pipe_33_E3", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_616_generated", "shape": null, "area": 0.64, "streetlevel": 738.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 738.0, "distance_right": 1.877787440964567e-07, "index_right": 623, "nodeid": "1386733.445003_5859203.660137", "id": "1386733.445003_5859203.660137", "name": "manhole_616_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386733.445003136992455, 5859203.660136871039867 ] } }, +{ "type": "Feature", "properties": { "_index": 615, "bedlevel": 735.0, "branchid": "pipe_33_E3;pipe_33_E4", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_617_generated", "shape": null, "area": 0.64, "streetlevel": 738.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 738.0, "distance_right": 3.9505892377035587e-07, "index_right": 624, "nodeid": "1386687.508547_5859217.718168", "id": "1386687.508547_5859217.718168", "name": "manhole_617_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386687.508546756347641, 5859217.718167688697577 ] } }, +{ "type": "Feature", "properties": { "_index": 616, "bedlevel": 760.29998779296875, "branchid": "pipe_33_E4;pipe_33_E5", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_618_generated", "shape": null, "area": 0.64, "streetlevel": 763.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 763.29998779296875, "distance_right": 6.1948814050446903e-07, "index_right": 625, "nodeid": "1386641.572090_5859231.776199", "id": "1386641.572090_5859231.776199", "name": "manhole_618_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386641.572090375469998, 5859231.776198507286608 ] } }, +{ "type": "Feature", "properties": { "_index": 617, "bedlevel": 760.29998779296875, "branchid": "pipe_33_E5;pipe_33_E6", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_619_generated", "shape": null, "area": 0.64, "streetlevel": 763.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 763.29998779296875, "distance_right": 4.9064792164743079e-07, "index_right": 626, "nodeid": "1386595.451642_5859245.168246", "id": "1386595.451642_5859245.168246", "name": "manhole_619_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386595.451642262749374, 5859245.168246414512396 ] } }, +{ "type": "Feature", "properties": { "_index": 618, "bedlevel": 751.60003662109375, "branchid": "pipe_33_E6;pipe_33_E7", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_620_generated", "shape": null, "area": 0.64, "streetlevel": 754.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 754.60003662109375, "distance_right": 4.9788017268457425e-07, "index_right": 627, "nodeid": "1386548.813361_5859256.685926", "id": "1386548.813361_5859256.685926", "name": "manhole_620_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386548.813360751140863, 5859256.685926430858672 ] } }, +{ "type": "Feature", "properties": { "_index": 619, "bedlevel": 751.60003662109375, "branchid": "pipe_33_E7;pipe_33_E8", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_621_generated", "shape": null, "area": 0.64, "streetlevel": 754.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 754.60003662109375, "distance_right": 5.0718835757375619e-07, "index_right": 628, "nodeid": "1386502.175079_5859268.203606", "id": "1386502.175079_5859268.203606", "name": "manhole_621_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386502.175079239532351, 5859268.203606447204947 ] } }, +{ "type": "Feature", "properties": { "_index": 620, "bedlevel": 739.5, "branchid": "pipe_33_E8;pipe_33_E9", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_622_generated", "shape": null, "area": 0.64, "streetlevel": 742.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 742.5, "distance_right": 5.6665798568557784e-07, "index_right": 629, "nodeid": "1386455.354357_5859278.943274", "id": "1386455.354357_5859278.943274", "name": "manhole_622_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386455.354356503346935, 5859278.943273726850748 ] } }, +{ "type": "Feature", "properties": { "_index": 621, "bedlevel": 739.5, "branchid": "pipe_33_E9;pipe_33_E10", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_623_generated", "shape": null, "area": 0.64, "streetlevel": 742.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 742.5, "distance_right": 2.9406242988679527e-07, "index_right": 630, "nodeid": "1386408.879240_5859290.671230", "id": "1386408.879240_5859290.671230", "name": "manhole_623_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386408.879239794565365, 5859290.671229789964855 ] } }, +{ "type": "Feature", "properties": { "_index": 622, "bedlevel": 714.60003662109375, "branchid": "pipe_33_E10;pipe_33_E11", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_624_generated", "shape": null, "area": 0.64, "streetlevel": 717.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 717.60003662109375, "distance_right": 3.9547400298640946e-07, "index_right": 631, "nodeid": "1386364.691369_5859309.518466", "id": "1386364.691369_5859309.518466", "name": "manhole_624_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386364.691368696978316, 5859309.518465746194124 ] } }, +{ "type": "Feature", "properties": { "_index": 623, "bedlevel": 714.60003662109375, "branchid": "pipe_33_E11;pipe_33_E12", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_625_generated", "shape": null, "area": 0.64, "streetlevel": 717.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 717.60003662109375, "distance_right": 4.9993553902667797e-07, "index_right": 632, "nodeid": "1386320.503498_5859328.365702", "id": "1386320.503498_5859328.365702", "name": "manhole_625_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386320.503497599391267, 5859328.365701701492071 ] } }, +{ "type": "Feature", "properties": { "_index": 624, "bedlevel": 708.0, "branchid": "pipe_33_E12", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_626_generated", "shape": null, "area": 0.64, "streetlevel": 711.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 711.0, "distance_right": 3.577770704512787e-07, "index_right": 633, "nodeid": "1386273.173812_5859335.365460", "id": "1386273.173812_5859335.365460", "name": "manhole_626_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386273.173811787506565, 5859335.36546028777957 ] } }, +{ "type": "Feature", "properties": { "_index": 625, "bedlevel": 950.70001220703125, "branchid": "pipe_34_E0;pipe_34_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_627_generated", "shape": null, "area": 0.64, "streetlevel": 953.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 953.70001220703125, "distance_right": 5.9695420529554627e-07, "index_right": 634, "nodeid": "1388922.246059_5860458.418739", "id": "1388922.246059_5860458.418739", "name": "manhole_627_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388922.246059404918924, 5860458.418739438988268 ] } }, +{ "type": "Feature", "properties": { "_index": 626, "bedlevel": 950.70001220703125, "branchid": "pipe_34_E1;pipe_34_E2", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_628_generated", "shape": null, "area": 0.64, "streetlevel": 953.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 953.70001220703125, "distance_right": 2.1646990066709852e-08, "index_right": 635, "nodeid": "1388900.295978_5860503.075898", "id": "1388900.295978_5860503.075898", "name": "manhole_628_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388900.295977992936969, 5860503.075897979550064 ] } }, +{ "type": "Feature", "properties": { "_index": 627, "bedlevel": 952.70001220703125, "branchid": "pipe_34_E2;pipe_34_E3", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_629_generated", "shape": null, "area": 0.64, "streetlevel": 955.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 955.70001220703125, "distance_right": 6.3678227575811753e-07, "index_right": 636, "nodeid": "1388878.345897_5860547.733057", "id": "1388878.345897_5860547.733057", "name": "manhole_629_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388878.345896581187844, 5860547.733056520111859 ] } }, +{ "type": "Feature", "properties": { "_index": 628, "bedlevel": 950.79998779296875, "branchid": "pipe_34_E3;pipe_34_E4", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_630_generated", "shape": null, "area": 0.64, "streetlevel": 953.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 953.79998779296875, "distance_right": 6.8182421614991291e-07, "index_right": 637, "nodeid": "1388856.887740_5860592.570928", "id": "1388856.887740_5860592.570928", "name": "manhole_630_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388856.887740465346724, 5860592.570927501656115 ] } }, +{ "type": "Feature", "properties": { "_index": 629, "bedlevel": 950.79998779296875, "branchid": "pipe_34_E4;pipe_34_E5", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_631_generated", "shape": null, "area": 0.64, "streetlevel": 953.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 953.79998779296875, "distance_right": 2.7419275813984667e-07, "index_right": 638, "nodeid": "1388853.076020_5860641.795407", "id": "1388853.076020_5860641.795407", "name": "manhole_631_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388853.076019846601412, 5860641.795407227240503 ] } }, +{ "type": "Feature", "properties": { "_index": 630, "bedlevel": 950.79998779296875, "branchid": "pipe_34_E5;pipe_34_E6", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_632_generated", "shape": null, "area": 0.64, "streetlevel": 953.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 953.79998779296875, "distance_right": 8.3497951232706373e-08, "index_right": 639, "nodeid": "1388856.119827_5860691.462329", "id": "1388856.119827_5860691.462329", "name": "manhole_632_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388856.119826921960339, 5860691.462329030036926 ] } }, +{ "type": "Feature", "properties": { "_index": 631, "bedlevel": 949.5, "branchid": "pipe_34_E6;pipe_34_E7", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_633_generated", "shape": null, "area": 0.64, "streetlevel": 952.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 952.5, "distance_right": 1.667342165101211e-07, "index_right": 640, "nodeid": "1388859.163634_5860741.129251", "id": "1388859.163634_5860741.129251", "name": "manhole_633_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388859.163633997086436, 5860741.12925083283335 ] } }, +{ "type": "Feature", "properties": { "_index": 632, "bedlevel": 949.5, "branchid": "pipe_34_E7;pipe_34_E8", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_634_generated", "shape": null, "area": 0.64, "streetlevel": 952.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 952.5, "distance_right": 3.7127669706251919e-07, "index_right": 641, "nodeid": "1388862.207441_5860790.796173", "id": "1388862.207441_5860790.796173", "name": "manhole_634_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388862.207441072445363, 5860790.796172635629773 ] } }, +{ "type": "Feature", "properties": { "_index": 633, "bedlevel": 942.5, "branchid": "pipe_34_E8;pipe_34_E9", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_635_generated", "shape": null, "area": 0.64, "streetlevel": 945.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 945.5, "distance_right": 2.0225358905841224e-07, "index_right": 642, "nodeid": "1388866.356326_5860840.344227", "id": "1388866.356326_5860840.344227", "name": "manhole_635_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388866.356326055014506, 5860840.344227194786072 ] } }, +{ "type": "Feature", "properties": { "_index": 634, "bedlevel": 942.5, "branchid": "pipe_34_E9;pipe_34_E10", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_636_generated", "shape": null, "area": 0.64, "streetlevel": 945.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 945.5, "distance_right": 3.8925384345881058e-07, "index_right": 643, "nodeid": "1388873.944741_5860889.522310", "id": "1388873.944741_5860889.522310", "name": "manhole_636_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388873.944740658160299, 5860889.522310186177492 ] } }, +{ "type": "Feature", "properties": { "_index": 635, "bedlevel": 942.5, "branchid": "pipe_34_E10;pipe_34_E11", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_637_generated", "shape": null, "area": 0.64, "streetlevel": 945.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 945.5, "distance_right": 3.0329102696444249e-07, "index_right": 644, "nodeid": "1388883.174273_5860938.398467", "id": "1388883.174273_5860938.398467", "name": "manhole_637_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388883.17427325528115, 5860938.398467163555324 ] } }, +{ "type": "Feature", "properties": { "_index": 636, "bedlevel": 934.4000244140625, "branchid": "pipe_34_E11;pipe_34_E12", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_638_generated", "shape": null, "area": 0.64, "streetlevel": 937.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 937.4000244140625, "distance_right": 1.6802195612188359e-07, "index_right": 645, "nodeid": "1388890.216841_5860987.212369", "id": "1388890.216841_5860987.212369", "name": "manhole_638_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388890.216840920504183, 5860987.212368851527572 ] } }, +{ "type": "Feature", "properties": { "_index": 637, "bedlevel": 934.4000244140625, "branchid": "pipe_34_E12;pipe_34_E13", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_639_generated", "shape": null, "area": 0.64, "streetlevel": 937.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 937.4000244140625, "distance_right": 1.1231997364245297e-07, "index_right": 646, "nodeid": "1388884.322195_5861036.622095", "id": "1388884.322195_5861036.622095", "name": "manhole_639_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388884.322194910608232, 5861036.62209493201226 ] } }, +{ "type": "Feature", "properties": { "_index": 638, "bedlevel": 934.4000244140625, "branchid": "pipe_34_E13;pipe_34_E14", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_640_generated", "shape": null, "area": 0.64, "streetlevel": 937.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 937.4000244140625, "distance_right": 9.9813494894073822e-08, "index_right": 647, "nodeid": "1388878.427549_5861086.031821", "id": "1388878.427549_5861086.031821", "name": "manhole_640_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388878.427548900712281, 5861086.031821011565626 ] } }, +{ "type": "Feature", "properties": { "_index": 639, "bedlevel": 927.4000244140625, "branchid": "pipe_34_E14;pipe_34_E15", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_641_generated", "shape": null, "area": 0.64, "streetlevel": 930.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 930.4000244140625, "distance_right": 1.4291648644270733e-07, "index_right": 648, "nodeid": "1388872.532903_5861135.441547", "id": "1388872.532903_5861135.441547", "name": "manhole_641_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388872.532902890816331, 5861135.441547092050314 ] } }, +{ "type": "Feature", "properties": { "_index": 640, "bedlevel": 927.4000244140625, "branchid": "pipe_34_E15;pipe_34_E16", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_642_generated", "shape": null, "area": 0.64, "streetlevel": 930.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 930.4000244140625, "distance_right": 2.093820748219209e-07, "index_right": 649, "nodeid": "1388866.638257_5861184.851273", "id": "1388866.638257_5861184.851273", "name": "manhole_642_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388866.63825688092038, 5861184.851273172535002 ] } }, +{ "type": "Feature", "properties": { "_index": 641, "bedlevel": 927.4000244140625, "branchid": "pipe_34_E16;pipe_34_E17", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_643_generated", "shape": null, "area": 0.64, "streetlevel": 930.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 930.4000244140625, "distance_right": 3.9648214779219621e-07, "index_right": 650, "nodeid": "1388854.620841_5861232.489913", "id": "1388854.620841_5861232.489913", "name": "manhole_643_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388854.620840607210994, 5861232.489912945777178 ] } }, +{ "type": "Feature", "properties": { "_index": 642, "bedlevel": 923.60003662109375, "branchid": "pipe_34_E17;pipe_34_E18", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_644_generated", "shape": null, "area": 0.64, "streetlevel": 926.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 926.60003662109375, "distance_right": 4.931566840797132e-07, "index_right": 651, "nodeid": "1388833.227561_5861277.416469", "id": "1388833.227561_5861277.416469", "name": "manhole_644_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388833.22756120422855, 5861277.416469449177384 ] } }, +{ "type": "Feature", "properties": { "_index": 643, "bedlevel": 923.60003662109375, "branchid": "pipe_34_E18;pipe_34_E19", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_645_generated", "shape": null, "area": 0.64, "streetlevel": 926.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 926.60003662109375, "distance_right": 2.0421729585515747e-07, "index_right": 652, "nodeid": "1388811.834282_5861322.343026", "id": "1388811.834282_5861322.343026", "name": "manhole_645_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388811.834281801246107, 5861322.343025953508914 ] } }, +{ "type": "Feature", "properties": { "_index": 644, "bedlevel": 928.10003662109375, "branchid": "pipe_34_E19;pipe_34_E20", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_646_generated", "shape": null, "area": 0.64, "streetlevel": 931.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 931.10003662109375, "distance_right": 6.0631692520020048e-07, "index_right": 653, "nodeid": "1388790.441002_5861367.269582", "id": "1388790.441002_5861367.269582", "name": "manhole_646_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388790.441002398030832, 5861367.26958245690912 ] } }, +{ "type": "Feature", "properties": { "_index": 645, "bedlevel": 919.20001220703125, "branchid": "pipe_34_E20;pipe_34_E21", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_647_generated", "shape": null, "area": 0.64, "streetlevel": 922.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 922.20001220703125, "distance_right": 4.0344250041906387e-08, "index_right": 654, "nodeid": "1388769.047723_5861412.196139", "id": "1388769.047723_5861412.196139", "name": "manhole_647_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388769.047722995048389, 5861412.196138960309327 ] } }, +{ "type": "Feature", "properties": { "_index": 646, "bedlevel": 919.20001220703125, "branchid": "pipe_34_E21;pipe_34_E22", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_648_generated", "shape": null, "area": 0.64, "streetlevel": 922.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 922.20001220703125, "distance_right": 6.1836242235722718e-07, "index_right": 655, "nodeid": "1388747.654444_5861457.122695", "id": "1388747.654444_5861457.122695", "name": "manhole_648_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388747.654443592065945, 5861457.122695464640856 ] } }, +{ "type": "Feature", "properties": { "_index": 647, "bedlevel": 919.20001220703125, "branchid": "pipe_34_E22;pipe_34_E23", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_649_generated", "shape": null, "area": 0.64, "streetlevel": 922.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 922.20001220703125, "distance_right": 4.2697769327700622e-07, "index_right": 656, "nodeid": "1388725.026127_5861501.410492", "id": "1388725.026127_5861501.410492", "name": "manhole_649_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388725.026126575190574, 5861501.410491958260536 ] } }, +{ "type": "Feature", "properties": { "_index": 648, "bedlevel": 897.20001220703125, "branchid": "pipe_34_E23;pipe_34_E24", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_650_generated", "shape": null, "area": 0.64, "streetlevel": 900.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 900.20001220703125, "distance_right": 3.8289478952932213e-07, "index_right": 657, "nodeid": "1388700.725248_5861544.833242", "id": "1388700.725248_5861544.833242", "name": "manhole_650_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388700.725248141447082, 5861544.833241644315422 ] } }, +{ "type": "Feature", "properties": { "_index": 649, "bedlevel": 897.20001220703125, "branchid": "pipe_34_E24;pipe_34_E25", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_651_generated", "shape": null, "area": 0.64, "streetlevel": 900.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 900.20001220703125, "distance_right": 4.4054123517975461e-07, "index_right": 658, "nodeid": "1388676.424370_5861588.255991", "id": "1388676.424370_5861588.255991", "name": "manhole_651_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388676.42436970770359, 5861588.255991329438984 ] } }, +{ "type": "Feature", "properties": { "_index": 650, "bedlevel": 897.20001220703125, "branchid": "pipe_34_E25;pipe_34_E26", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_652_generated", "shape": null, "area": 0.64, "streetlevel": 900.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 900.20001220703125, "distance_right": 3.923347648023898e-07, "index_right": 659, "nodeid": "1388632.324465_5861606.441272", "id": "1388632.324465_5861606.441272", "name": "manhole_652_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388632.324464634526521, 5861606.441272142343223 ] } }, +{ "type": "Feature", "properties": { "_index": 651, "bedlevel": 895.4000244140625, "branchid": "pipe_34_E26;pipe_34_E27", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_653_generated", "shape": null, "area": 0.64, "streetlevel": 898.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 898.4000244140625, "distance_right": 5.2422671262703447e-07, "index_right": 660, "nodeid": "1388583.463808_5861611.105615", "id": "1388583.463808_5861611.105615", "name": "manhole_653_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388583.463808472501114, 5861611.105615227483213 ] } }, +{ "type": "Feature", "properties": { "_index": 652, "bedlevel": 895.4000244140625, "branchid": "pipe_34_E27;pipe_34_E28", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_654_generated", "shape": null, "area": 0.64, "streetlevel": 898.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 898.4000244140625, "distance_right": 1.7655441931671308e-07, "index_right": 661, "nodeid": "1388534.764013_5861604.222018", "id": "1388534.764013_5861604.222018", "name": "manhole_654_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388534.764012826373801, 5861604.222017968073487 ] } }, +{ "type": "Feature", "properties": { "_index": 653, "bedlevel": 900.60003662109375, "branchid": "pipe_34_E28;pipe_34_E29", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_655_generated", "shape": null, "area": 0.64, "streetlevel": 903.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 903.60003662109375, "distance_right": 1.267805079935303e-07, "index_right": 662, "nodeid": "1388489.566489_5861583.407318", "id": "1388489.566489_5861583.407318", "name": "manhole_655_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388489.566489090910181, 5861583.40731808822602 ] } }, +{ "type": "Feature", "properties": { "_index": 654, "bedlevel": 900.60003662109375, "branchid": "pipe_34_E29;pipe_34_E30", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_656_generated", "shape": null, "area": 0.64, "streetlevel": 903.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 903.60003662109375, "distance_right": 3.5366016764945169e-07, "index_right": 663, "nodeid": "1388444.204916_5861563.162508", "id": "1388444.204916_5861563.162508", "name": "manhole_656_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388444.204915680922568, 5861563.162508152425289 ] } }, +{ "type": "Feature", "properties": { "_index": 655, "bedlevel": 903.4000244140625, "branchid": "pipe_34_E30;pipe_34_E31", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_657_generated", "shape": null, "area": 0.64, "streetlevel": 906.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 906.4000244140625, "distance_right": 5.7176550681391025e-07, "index_right": 664, "nodeid": "1388394.858231_5861556.761521", "id": "1388394.858231_5861556.761521", "name": "manhole_657_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388394.858231473481283, 5861556.761520680040121 ] } }, +{ "type": "Feature", "properties": { "_index": 656, "bedlevel": 903.4000244140625, "branchid": "pipe_34_E31;pipe_34_E32", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_658_generated", "shape": null, "area": 0.64, "streetlevel": 906.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 906.4000244140625, "distance_right": 2.8018892283096598e-07, "index_right": 665, "nodeid": "1388350.680838_5861570.408674", "id": "1388350.680838_5861570.408674", "name": "manhole_658_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388350.680838279658929, 5861570.408674017526209 ] } }, +{ "type": "Feature", "properties": { "_index": 657, "bedlevel": 897.20001220703125, "branchid": "pipe_34_E32;pipe_34_E33", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_659_generated", "shape": null, "area": 0.64, "streetlevel": 900.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 900.20001220703125, "distance_right": 4.057703762092192e-07, "index_right": 666, "nodeid": "1388310.581733_5861599.872714", "id": "1388310.581733_5861599.872714", "name": "manhole_659_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388310.581732882419601, 5861599.872713611461222 ] } }, +{ "type": "Feature", "properties": { "_index": 658, "bedlevel": 897.20001220703125, "branchid": "pipe_34_E33;pipe_34_E34", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_660_generated", "shape": null, "area": 0.64, "streetlevel": 900.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 900.20001220703125, "distance_right": 5.5718800522406768e-07, "index_right": 667, "nodeid": "1388271.039626_5861629.969603", "id": "1388271.039626_5861629.969603", "name": "manhole_660_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388271.039625711739063, 5861629.969603477045894 ] } }, +{ "type": "Feature", "properties": { "_index": 659, "bedlevel": 887.0, "branchid": "pipe_34_E34;pipe_34_E35", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_661_generated", "shape": null, "area": 0.64, "streetlevel": 890.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 890.0, "distance_right": 3.3198253484132111e-07, "index_right": 668, "nodeid": "1388236.722210_5861666.002684", "id": "1388236.722210_5861666.002684", "name": "manhole_661_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388236.722210306907073, 5861666.002683873288333 ] } }, +{ "type": "Feature", "properties": { "_index": 660, "bedlevel": 887.0, "branchid": "pipe_34_E35;pipe_34_E36", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_662_generated", "shape": null, "area": 0.64, "streetlevel": 890.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 890.0, "distance_right": 2.8636616923067504e-07, "index_right": 669, "nodeid": "1388202.404795_5861702.035764", "id": "1388202.404795_5861702.035764", "name": "manhole_662_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388202.404794902307913, 5861702.035764269530773 ] } }, +{ "type": "Feature", "properties": { "_index": 661, "bedlevel": 887.0, "branchid": "pipe_34_E36;pipe_34_E37", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_663_generated", "shape": null, "area": 0.64, "streetlevel": 890.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 890.0, "distance_right": 5.9945933282054772e-07, "index_right": 670, "nodeid": "1388168.087379_5861738.068845", "id": "1388168.087379_5861738.068845", "name": "manhole_663_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388168.087379497475922, 5861738.068844665773213 ] } }, +{ "type": "Feature", "properties": { "_index": 662, "bedlevel": 882.9000244140625, "branchid": "pipe_34_E37;pipe_34_E38", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_664_generated", "shape": null, "area": 0.64, "streetlevel": 885.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 885.9000244140625, "distance_right": 1.1171698567518565e-07, "index_right": 671, "nodeid": "1388133.769964_5861774.101925", "id": "1388133.769964_5861774.101925", "name": "manhole_664_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388133.769964092643932, 5861774.101925062015653 ] } }, +{ "type": "Feature", "properties": { "_index": 663, "bedlevel": 871.0, "branchid": "pipe_34_E38;pipe_34_E39", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_665_generated", "shape": null, "area": 0.64, "streetlevel": 874.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 874.0, "distance_right": 5.5370519548127108e-07, "index_right": 672, "nodeid": "1388099.452549_5861810.135005", "id": "1388099.452549_5861810.135005", "name": "manhole_665_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388099.452548687811941, 5861810.13500545732677 ] } }, +{ "type": "Feature", "properties": { "_index": 664, "bedlevel": 871.0, "branchid": "pipe_34_E39;pipe_34_E40", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_666_generated", "shape": null, "area": 0.64, "streetlevel": 874.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 874.0, "distance_right": 3.1864981069759395e-07, "index_right": 673, "nodeid": "1388065.135133_5861846.168086", "id": "1388065.135133_5861846.168086", "name": "manhole_666_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388065.135133283212781, 5861846.16808585356921 ] } }, +{ "type": "Feature", "properties": { "_index": 665, "bedlevel": 859.20001220703125, "branchid": "pipe_34_E40;pipe_34_E41", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_667_generated", "shape": null, "area": 0.64, "streetlevel": 862.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 862.20001220703125, "distance_right": 3.6733334325308476e-07, "index_right": 674, "nodeid": "1388022.995197_5861866.899685", "id": "1388022.995197_5861866.899685", "name": "manhole_667_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388022.995196633273736, 5861866.899685021489859 ] } }, +{ "type": "Feature", "properties": { "_index": 666, "bedlevel": 859.20001220703125, "branchid": "pipe_34_E41;pipe_34_E42", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_668_generated", "shape": null, "area": 0.64, "streetlevel": 862.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 862.20001220703125, "distance_right": 5.3807499256072629e-07, "index_right": 675, "nodeid": "1387973.690500_5861873.616436", "id": "1387973.690500_5861873.616436", "name": "manhole_668_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387973.690499771386385, 5861873.616436487063766 ] } }, +{ "type": "Feature", "properties": { "_index": 667, "bedlevel": 856.20001220703125, "branchid": "pipe_34_E42;pipe_34_E43", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_669_generated", "shape": null, "area": 0.64, "streetlevel": 859.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 859.20001220703125, "distance_right": 5.474378737578715e-07, "index_right": 676, "nodeid": "1387924.470484_5861880.906597", "id": "1387924.470484_5861880.906597", "name": "manhole_669_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387924.470484273741022, 5861880.90659652557224 ] } }, +{ "type": "Feature", "properties": { "_index": 668, "bedlevel": 856.20001220703125, "branchid": "pipe_34_E43;pipe_34_E44", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_670_generated", "shape": null, "area": 0.64, "streetlevel": 859.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 859.20001220703125, "distance_right": 2.6713630888038328e-07, "index_right": 677, "nodeid": "1387877.962617_5861896.157046", "id": "1387877.962617_5861896.157046", "name": "manhole_670_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387877.962616891367361, 5861896.157046243548393 ] } }, +{ "type": "Feature", "properties": { "_index": 669, "bedlevel": 856.20001220703125, "branchid": "pipe_34_E44;pipe_34_E45", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_671_generated", "shape": null, "area": 0.64, "streetlevel": 859.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 859.20001220703125, "distance_right": 2.3805860219097484e-07, "index_right": 678, "nodeid": "1387917.070526_5861911.915830", "id": "1387917.070526_5861911.915830", "name": "manhole_671_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387917.070526217576116, 5861911.915829903446138 ] } }, +{ "type": "Feature", "properties": { "_index": 670, "bedlevel": 856.20001220703125, "branchid": "pipe_34_E45;pipe_34_E46", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_672_generated", "shape": null, "area": 0.64, "streetlevel": 859.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 859.20001220703125, "distance_right": 4.3134922908785989e-07, "index_right": 679, "nodeid": "1387966.654668_5861916.096835", "id": "1387966.654668_5861916.096835", "name": "manhole_672_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387966.654667611001059, 5861916.096835186704993 ] } }, +{ "type": "Feature", "properties": { "_index": 671, "bedlevel": 843.29998779296875, "branchid": "pipe_34_E46;pipe_34_E47", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_673_generated", "shape": null, "area": 0.64, "streetlevel": 846.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 846.29998779296875, "distance_right": 6.6910196134826447e-07, "index_right": 680, "nodeid": "1388016.318006_5861919.063731", "id": "1388016.318006_5861919.063731", "name": "manhole_673_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388016.318005530629307, 5861919.063731476664543 ] } }, +{ "type": "Feature", "properties": { "_index": 672, "bedlevel": 847.10003662109375, "branchid": "pipe_34_E47;pipe_34_E48", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_674_generated", "shape": null, "area": 0.64, "streetlevel": 850.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 850.10003662109375, "distance_right": 4.9533251570249879e-07, "index_right": 681, "nodeid": "1388066.025121_5861921.359511", "id": "1388066.025121_5861921.359511", "name": "manhole_674_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388066.025120510486886, 5861921.359510923735797 ] } }, +{ "type": "Feature", "properties": { "_index": 673, "bedlevel": 847.10003662109375, "branchid": "pipe_34_E48;pipe_34_E49", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_675_generated", "shape": null, "area": 0.64, "streetlevel": 850.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 850.10003662109375, "distance_right": 6.1467730890167978e-07, "index_right": 682, "nodeid": "1388115.732235_5861923.655290", "id": "1388115.732235_5861923.655290", "name": "manhole_675_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388115.732235490344465, 5861923.655290370807052 ] } }, +{ "type": "Feature", "properties": { "_index": 674, "bedlevel": 846.0, "branchid": "pipe_34_E49;pipe_34_E50", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_676_generated", "shape": null, "area": 0.64, "streetlevel": 849.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 849.0, "distance_right": 3.5555129936383504e-07, "index_right": 683, "nodeid": "1388161.130695_5861931.457672", "id": "1388161.130695_5861931.457672", "name": "manhole_676_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388161.130695321131498, 5861931.457672152668238 ] } }, +{ "type": "Feature", "properties": { "_index": 675, "bedlevel": 847.10003662109375, "branchid": "pipe_34_E50;pipe_34_E51", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_677_generated", "shape": null, "area": 0.64, "streetlevel": 850.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 850.10003662109375, "distance_right": 2.672133099130381e-07, "index_right": 684, "nodeid": "1388139.871224_5861964.082641", "id": "1388139.871224_5861964.082641", "name": "manhole_677_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388139.871223766123876, 5861964.082641129381955 ] } }, +{ "type": "Feature", "properties": { "_index": 676, "bedlevel": 847.10003662109375, "branchid": "pipe_34_E51;pipe_34_E52", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_678_generated", "shape": null, "area": 0.64, "streetlevel": 850.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 850.10003662109375, "distance_right": 3.921092014707088e-07, "index_right": 685, "nodeid": "1388090.726846_5861957.769498", "id": "1388090.726846_5861957.769498", "name": "manhole_678_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388090.726845995755866, 5861957.769498392008245 ] } }, +{ "type": "Feature", "properties": { "_index": 677, "bedlevel": 843.29998779296875, "branchid": "pipe_34_E52;pipe_34_E53", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_679_generated", "shape": null, "area": 0.64, "streetlevel": 846.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 846.29998779296875, "distance_right": 2.2779084516867197e-07, "index_right": 686, "nodeid": "1388049.339105_5861983.736727", "id": "1388049.339105_5861983.736727", "name": "manhole_679_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388049.339104855433106, 5861983.736727176234126 ] } }, +{ "type": "Feature", "properties": { "_index": 678, "bedlevel": 843.29998779296875, "branchid": "pipe_34_E53;pipe_34_E54", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_680_generated", "shape": null, "area": 0.64, "streetlevel": 846.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 846.29998779296875, "distance_right": 4.6927575053310853e-07, "index_right": 687, "nodeid": "1388024.713076_5862026.975906", "id": "1388024.713076_5862026.975906", "name": "manhole_680_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388024.713075590552762, 5862026.975905770435929 ] } }, +{ "type": "Feature", "properties": { "_index": 679, "bedlevel": 843.29998779296875, "branchid": "pipe_34_E54;pipe_34_E55", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_681_generated", "shape": null, "area": 0.64, "streetlevel": 846.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 846.29998779296875, "distance_right": 3.7928111851215363e-07, "index_right": 688, "nodeid": "1387980.016218_5862047.702198", "id": "1387980.016218_5862047.702198", "name": "manhole_681_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387980.016218039905652, 5862047.702198376879096 ] } }, +{ "type": "Feature", "properties": { "_index": 680, "bedlevel": 790.5, "branchid": "pipe_34_E55;pipe_34_E56", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_682_generated", "shape": null, "area": 0.64, "streetlevel": 793.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 793.5, "distance_right": 5.3642689716381333e-07, "index_right": 689, "nodeid": "1387931.906731_5862056.853297", "id": "1387931.906731_5862056.853297", "name": "manhole_682_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387931.90673128189519, 5862056.853296543471515 ] } }, +{ "type": "Feature", "properties": { "_index": 681, "bedlevel": 790.5, "branchid": "pipe_34_E56;pipe_34_E57", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_683_generated", "shape": null, "area": 0.64, "streetlevel": 793.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 793.5, "distance_right": 6.560974611428636e-07, "index_right": 690, "nodeid": "1387882.187313_5862058.865105", "id": "1387882.187313_5862058.865105", "name": "manhole_683_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387882.187313467729837, 5862058.865105460397899 ] } }, +{ "type": "Feature", "properties": { "_index": 682, "bedlevel": 790.20001220703125, "branchid": "pipe_34_E57;pipe_34_E58", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_684_generated", "shape": null, "area": 0.64, "streetlevel": 793.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 793.20001220703125, "distance_right": 3.4705732931458691e-07, "index_right": 691, "nodeid": "1387832.722497_5862057.341085", "id": "1387832.722497_5862057.341085", "name": "manhole_684_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387832.722497318405658, 5862057.3410848621279 ] } }, +{ "type": "Feature", "properties": { "_index": 683, "bedlevel": 827.29998779296875, "branchid": "pipe_34_E58;pipe_34_E59", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_685_generated", "shape": null, "area": 0.64, "streetlevel": 830.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 830.29998779296875, "distance_right": 3.9864767552081094e-07, "index_right": 692, "nodeid": "1387783.804231_5862048.226751", "id": "1387783.804231_5862048.226751", "name": "manhole_685_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387783.80423084856011, 5862048.226750630885363 ] } }, +{ "type": "Feature", "properties": { "_index": 684, "bedlevel": 814.70001220703125, "branchid": "pipe_34_E59;pipe_34_E60", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_686_generated", "shape": null, "area": 0.64, "streetlevel": 817.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 817.70001220703125, "distance_right": 5.5057358477645188e-07, "index_right": 693, "nodeid": "1387734.885964_5862039.112416", "id": "1387734.885964_5862039.112416", "name": "manhole_686_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387734.885964378714561, 5862039.112416399642825 ] } }, +{ "type": "Feature", "properties": { "_index": 685, "bedlevel": 810.70001220703125, "branchid": "pipe_34_E60;pipe_34_E61", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_687_generated", "shape": null, "area": 0.64, "streetlevel": 813.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 813.70001220703125, "distance_right": 1.9158114081199618e-07, "index_right": 694, "nodeid": "1387685.967698_5862029.998082", "id": "1387685.967698_5862029.998082", "name": "manhole_687_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387685.967697908869013, 5862029.998082168400288 ] } }, +{ "type": "Feature", "properties": { "_index": 686, "bedlevel": 810.70001220703125, "branchid": "pipe_34_E61;pipe_34_E62", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_688_generated", "shape": null, "area": 0.64, "streetlevel": 813.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 813.70001220703125, "distance_right": 4.5903439743479076e-07, "index_right": 695, "nodeid": "1387637.036116_5862020.957141", "id": "1387637.036116_5862020.957141", "name": "manhole_688_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387637.036115845199674, 5862020.957140567712486 ] } }, +{ "type": "Feature", "properties": { "_index": 687, "bedlevel": 804.0, "branchid": "pipe_34_E62;pipe_34_E63", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_689_generated", "shape": null, "area": 0.64, "streetlevel": 807.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.0, "distance_right": 4.9447928351944995e-07, "index_right": 696, "nodeid": "1387588.033850_5862012.305794", "id": "1387588.033850_5862012.305794", "name": "manhole_689_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387588.033849656581879, 5862012.305794355459511 ] } }, +{ "type": "Feature", "properties": { "_index": 688, "bedlevel": 804.0, "branchid": "pipe_34_E63;pipe_34_E64", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_690_generated", "shape": null, "area": 0.64, "streetlevel": 807.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 807.0, "distance_right": 4.8969642604152781e-07, "index_right": 697, "nodeid": "1387539.031583_5862003.654448", "id": "1387539.031583_5862003.654448", "name": "manhole_690_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387539.031583468196914, 5862003.654448143206537 ] } }, +{ "type": "Feature", "properties": { "_index": 689, "bedlevel": 790.10003662109375, "branchid": "pipe_34_E64;pipe_34_E65", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_691_generated", "shape": null, "area": 0.64, "streetlevel": 793.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 793.10003662109375, "distance_right": 2.8799720097075195e-07, "index_right": 698, "nodeid": "1387490.029317_5861995.003102", "id": "1387490.029317_5861995.003102", "name": "manhole_691_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387490.029317279579118, 5861995.003101930953562 ] } }, +{ "type": "Feature", "properties": { "_index": 690, "bedlevel": 790.10003662109375, "branchid": "pipe_34_E65;pipe_34_E66", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_692_generated", "shape": null, "area": 0.64, "streetlevel": 793.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 793.10003662109375, "distance_right": 3.8909253916758981e-07, "index_right": 699, "nodeid": "1387440.720368_5861989.908139", "id": "1387440.720368_5861989.908139", "name": "manhole_692_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387440.720367865404114, 5861989.908138634636998 ] } }, +{ "type": "Feature", "properties": { "_index": 691, "bedlevel": 767.60003662109375, "branchid": "pipe_34_E66;pipe_34_E67", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_693_generated", "shape": null, "area": 0.64, "streetlevel": 770.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 770.60003662109375, "distance_right": 3.3575341333343036e-07, "index_right": 700, "nodeid": "1387390.960447_5861990.042768", "id": "1387390.960447_5861990.042768", "name": "manhole_693_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387390.960446665296331, 5861990.042768024839461 ] } }, +{ "type": "Feature", "properties": { "_index": 692, "bedlevel": 767.60003662109375, "branchid": "pipe_34_E67;pipe_34_E68", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_694_generated", "shape": null, "area": 0.64, "streetlevel": 770.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 770.60003662109375, "distance_right": 6.2320378403686381e-07, "index_right": 701, "nodeid": "1387341.200525_5861990.177397", "id": "1387341.200525_5861990.177397", "name": "manhole_694_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387341.200525465421379, 5861990.177397414110601 ] } }, +{ "type": "Feature", "properties": { "_index": 693, "bedlevel": 746.60003662109375, "branchid": "pipe_34_E68;pipe_34_E69", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_695_generated", "shape": null, "area": 0.64, "streetlevel": 749.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 749.60003662109375, "distance_right": 3.2988750062887901e-07, "index_right": 702, "nodeid": "1387291.440604_5861990.312027", "id": "1387291.440604_5861990.312027", "name": "manhole_695_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387291.440604265546426, 5861990.312026804313064 ] } }, +{ "type": "Feature", "properties": { "_index": 694, "bedlevel": 746.60003662109375, "branchid": "pipe_34_E69;pipe_34_E70", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_696_generated", "shape": null, "area": 0.64, "streetlevel": 749.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 749.60003662109375, "distance_right": 5.3662372160015116e-07, "index_right": 703, "nodeid": "1387246.706285_5861974.212806", "id": "1387246.706285_5861974.212806", "name": "manhole_696_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387246.706285298336297, 5861974.212805554270744 ] } }, +{ "type": "Feature", "properties": { "_index": 695, "bedlevel": 744.0, "branchid": "pipe_34_E70;pipe_34_E71", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_697_generated", "shape": null, "area": 0.64, "streetlevel": 747.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 747.0, "distance_right": 2.9919235981069635e-07, "index_right": 704, "nodeid": "1387205.725989_5861945.987229", "id": "1387205.725989_5861945.987229", "name": "manhole_697_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387205.725988702848554, 5861945.987228964455426 ] } }, +{ "type": "Feature", "properties": { "_index": 696, "bedlevel": 768.79998779296875, "branchid": "pipe_34_E71;pipe_34_E72", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_698_generated", "shape": null, "area": 0.64, "streetlevel": 771.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 771.79998779296875, "distance_right": 3.8940979095391863e-07, "index_right": 705, "nodeid": "1387164.745692_5861917.761652", "id": "1387164.745692_5861917.761652", "name": "manhole_698_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387164.745692107127979, 5861917.761652374640107 ] } }, +{ "type": "Feature", "properties": { "_index": 697, "bedlevel": 761.10003662109375, "branchid": "pipe_34_E72;pipe_34_E73", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_699_generated", "shape": null, "area": 0.64, "streetlevel": 764.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 764.10003662109375, "distance_right": 4.3735146338226453e-07, "index_right": 706, "nodeid": "1387115.569934_5861911.215812", "id": "1387115.569934_5861911.215812", "name": "manhole_699_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387115.569933785125613, 5861911.215812381356955 ] } }, +{ "type": "Feature", "properties": { "_index": 698, "bedlevel": 761.10003662109375, "branchid": "pipe_34_E73;pipe_34_E74", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_700_generated", "shape": null, "area": 0.64, "streetlevel": 764.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 764.10003662109375, "distance_right": 4.4995899873023288e-07, "index_right": 707, "nodeid": "1387066.165866_5861905.273926", "id": "1387066.165866_5861905.273926", "name": "manhole_700_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387066.165866439929232, 5861905.273926095105708 ] } }, +{ "type": "Feature", "properties": { "_index": 699, "bedlevel": 744.70001220703125, "branchid": "pipe_34_E74;pipe_34_E75", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_701_generated", "shape": null, "area": 0.64, "streetlevel": 747.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 747.70001220703125, "distance_right": 4.8367488329805678e-07, "index_right": 708, "nodeid": "1387016.666836_5861900.238133", "id": "1387016.666836_5861900.238133", "name": "manhole_701_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387016.666836149292067, 5861900.238133460283279 ] } }, +{ "type": "Feature", "properties": { "_index": 700, "bedlevel": 744.70001220703125, "branchid": "pipe_34_E75;pipe_34_E76", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_702_generated", "shape": null, "area": 0.64, "streetlevel": 747.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 747.70001220703125, "distance_right": 4.5868611841636618e-07, "index_right": 709, "nodeid": "1386975.698310_5861874.842493", "id": "1386975.698310_5861874.842493", "name": "manhole_702_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386975.698310127714649, 5861874.842493440955877 ] } }, +{ "type": "Feature", "properties": { "_index": 701, "bedlevel": 736.60003662109375, "branchid": "pipe_34_E76;pipe_34_E77", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_703_generated", "shape": null, "area": 0.64, "streetlevel": 739.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 739.60003662109375, "distance_right": 2.4490286576639853e-07, "index_right": 710, "nodeid": "1386937.286020_5861843.210803", "id": "1386937.286020_5861843.210803", "name": "manhole_703_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386937.286019780673087, 5861843.21080310922116 ] } }, +{ "type": "Feature", "properties": { "_index": 702, "bedlevel": 736.60003662109375, "branchid": "pipe_34_E77;pipe_34_E78", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_704_generated", "shape": null, "area": 0.64, "streetlevel": 739.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 739.60003662109375, "distance_right": 4.8711559489137913e-07, "index_right": 711, "nodeid": "1386898.873729_5861811.579113", "id": "1386898.873729_5861811.579113", "name": "manhole_704_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386898.873729433864355, 5861811.579112778417766 ] } }, +{ "type": "Feature", "properties": { "_index": 703, "bedlevel": 752.20001220703125, "branchid": "pipe_34_E78;pipe_34_E79", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_705_generated", "shape": null, "area": 0.64, "streetlevel": 755.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 755.20001220703125, "distance_right": 4.5635115012089555e-07, "index_right": 712, "nodeid": "1386860.461439_5861779.947422", "id": "1386860.461439_5861779.947422", "name": "manhole_705_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386860.461439087055624, 5861779.947422447614372 ] } }, +{ "type": "Feature", "properties": { "_index": 704, "bedlevel": 742.29998779296875, "branchid": "pipe_34_E79;pipe_34_E80", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_706_generated", "shape": null, "area": 0.64, "streetlevel": 745.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 745.29998779296875, "distance_right": 2.8455915079755038e-07, "index_right": 713, "nodeid": "1386822.049149_5861748.315732", "id": "1386822.049149_5861748.315732", "name": "manhole_706_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386822.049148740014061, 5861748.315732115879655 ] } }, +{ "type": "Feature", "properties": { "_index": 705, "bedlevel": 742.29998779296875, "branchid": "pipe_34_E80;pipe_34_E81", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_707_generated", "shape": null, "area": 0.64, "streetlevel": 745.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 745.29998779296875, "distance_right": 3.5457500391329842e-07, "index_right": 714, "nodeid": "1386774.418702_5861733.958942", "id": "1386774.418702_5861733.958942", "name": "manhole_707_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386774.418702265014872, 5861733.958941764198244 ] } }, +{ "type": "Feature", "properties": { "_index": 706, "bedlevel": 721.29998779296875, "branchid": "pipe_34_E81;pipe_34_E82", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_708_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 3.9676643957092681e-07, "index_right": 715, "nodeid": "1386726.757215_5861719.660322", "id": "1386726.757215_5861719.660322", "name": "manhole_708_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386726.75721522886306, 5861719.660321676172316 ] } }, +{ "type": "Feature", "properties": { "_index": 707, "bedlevel": 721.29998779296875, "branchid": "pipe_34_E82;pipe_34_E83", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_709_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 6.4005122766323423e-07, "index_right": 716, "nodeid": "1386681.211288_5861700.510516", "id": "1386681.211288_5861700.510516", "name": "manhole_709_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386681.211287560872734, 5861700.510515534318984 ] } }, +{ "type": "Feature", "properties": { "_index": 708, "bedlevel": 774.9000244140625, "branchid": "pipe_34_E83;pipe_34_E84", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_710_generated", "shape": null, "area": 0.64, "streetlevel": 777.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 777.9000244140625, "distance_right": 1.6268731961636028e-07, "index_right": 717, "nodeid": "1386655.081909_5861659.807658", "id": "1386655.081909_5861659.807658", "name": "manhole_710_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386655.081909105414525, 5861659.807657876051962 ] } }, +{ "type": "Feature", "properties": { "_index": 709, "bedlevel": 755.79998779296875, "branchid": "pipe_34_E84;pipe_34_E85", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_711_generated", "shape": null, "area": 0.64, "streetlevel": 758.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 758.79998779296875, "distance_right": 4.863711772445947e-07, "index_right": 718, "nodeid": "1386647.411753_5861610.757949", "id": "1386647.411753_5861610.757949", "name": "manhole_711_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386647.41175345890224, 5861610.757949161343277 ] } }, +{ "type": "Feature", "properties": { "_index": 710, "bedlevel": 755.79998779296875, "branchid": "pipe_34_E85;pipe_34_E86", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_712_generated", "shape": null, "area": 0.64, "streetlevel": 758.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 758.79998779296875, "distance_right": 4.9930356460427038e-07, "index_right": 719, "nodeid": "1386641.745189_5861561.363540", "id": "1386641.745189_5861561.363540", "name": "manhole_712_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386641.745189253240824, 5861561.363539570011199 ] } }, +{ "type": "Feature", "properties": { "_index": 711, "bedlevel": 729.4000244140625, "branchid": "pipe_34_E86;pipe_34_E87", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_713_generated", "shape": null, "area": 0.64, "streetlevel": 732.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 732.4000244140625, "distance_right": 2.7534652721036083e-07, "index_right": 720, "nodeid": "1386642.371349_5861511.607376", "id": "1386642.371349_5861511.607376", "name": "manhole_713_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386642.37134926696308, 5861511.607376066967845 ] } }, +{ "type": "Feature", "properties": { "_index": 712, "bedlevel": 729.4000244140625, "branchid": "pipe_34_E87;pipe_34_E88", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_714_generated", "shape": null, "area": 0.64, "streetlevel": 732.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 732.4000244140625, "distance_right": 5.1860291152319888e-07, "index_right": 721, "nodeid": "1386642.997509_5861461.851213", "id": "1386642.997509_5861461.851213", "name": "manhole_714_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386642.997509280918166, 5861461.851212563924491 ] } }, +{ "type": "Feature", "properties": { "_index": 713, "bedlevel": 729.4000244140625, "branchid": "pipe_34_E88;pipe_34_E89", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_715_generated", "shape": null, "area": 0.64, "streetlevel": 732.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 732.4000244140625, "distance_right": 3.008763845900145e-07, "index_right": 722, "nodeid": "1386643.623669_5861412.095049", "id": "1386643.623669_5861412.095049", "name": "manhole_715_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386643.623669294640422, 5861412.09504906181246 ] } }, +{ "type": "Feature", "properties": { "_index": 715, "bedlevel": 777.79998779296875, "branchid": "pipe_35_E0;pipe_36_E0;pipe_37_E0", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_716_generated", "shape": null, "area": 0.64, "streetlevel": 780.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 780.79998779296875, "distance_right": 2.3980109538029568e-07, "index_right": 723, "nodeid": "1386060.978602_5859873.390329", "id": "1386060.978602_5859873.390329", "name": "manhole_716_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386060.978602184914052, 5859873.390328846871853 ] } }, +{ "type": "Feature", "properties": { "_index": 715, "bedlevel": 777.79998779296875, "branchid": "pipe_35_E0;pipe_35_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_717_generated", "shape": null, "area": 0.64, "streetlevel": 780.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 780.79998779296875, "distance_right": 5.4068790112897243e-07, "index_right": 724, "nodeid": "1386078.544554_5859857.065600", "id": "1386078.544554_5859857.065600", "name": "manhole_717_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386078.54455375042744, 5859857.065600479952991 ] } }, +{ "type": "Feature", "properties": { "_index": 716, "bedlevel": 777.79998779296875, "branchid": "pipe_35_E1;pipe_38_E0;pipe_39_E0", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_718_generated", "shape": null, "area": 0.64, "streetlevel": 780.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 780.79998779296875, "distance_right": 5.758455387466089e-07, "index_right": 725, "nodeid": "1386079.866959_5859885.500409", "id": "1386079.866959_5859885.500409", "name": "manhole_718_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386079.86695942771621, 5859885.500408614054322 ] } }, +{ "type": "Feature", "properties": { "_index": 717, "bedlevel": 777.79998779296875, "branchid": "pipe_36_E0", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_719_generated", "shape": null, "area": 0.64, "streetlevel": 780.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 780.79998779296875, "distance_right": 5.0283226172582603e-07, "index_right": 726, "nodeid": "1386030.926458_5859869.881591", "id": "1386030.926458_5859869.881591", "name": "manhole_719_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386030.926458492642269, 5859869.881591100245714 ] } }, +{ "type": "Feature", "properties": { "_index": 718, "bedlevel": 763.29998779296875, "branchid": "pipe_37_E0", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_720_generated", "shape": null, "area": 0.64, "streetlevel": 766.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 766.29998779296875, "distance_right": 2.4131141216608354e-07, "index_right": 727, "nodeid": "1386043.381106_5859908.119292", "id": "1386043.381106_5859908.119292", "name": "manhole_720_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386043.381105761509389, 5859908.11929196305573 ] } }, +{ "type": "Feature", "properties": { "_index": 719, "bedlevel": 763.29998779296875, "branchid": "pipe_38_E0;pipe_38_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_721_generated", "shape": null, "area": 0.64, "streetlevel": 766.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 766.29998779296875, "distance_right": 4.3100518037512075e-07, "index_right": 728, "nodeid": "1386081.403634_5859934.756706", "id": "1386081.403634_5859934.756706", "name": "manhole_721_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386081.40363402524963, 5859934.756705570034683 ] } }, +{ "type": "Feature", "properties": { "_index": 720, "bedlevel": 763.29998779296875, "branchid": "pipe_38_E1;pipe_38_E2", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_722_generated", "shape": null, "area": 0.64, "streetlevel": 766.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 766.29998779296875, "distance_right": 2.071517671303778e-07, "index_right": 729, "nodeid": "1386080.471782_5859983.948014", "id": "1386080.471782_5859983.948014", "name": "manhole_722_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386080.471781946951523, 5859983.948014200665057 ] } }, +{ "type": "Feature", "properties": { "_index": 721, "bedlevel": 753.5, "branchid": "pipe_38_E2;pipe_39_E3;pipe_40_E0", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_723_generated", "shape": null, "area": 0.64, "streetlevel": 756.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 756.5, "distance_right": 1.3487809052132004e-07, "index_right": 730, "nodeid": "1386081.101270_5860033.019892", "id": "1386081.101270_5860033.019892", "name": "manhole_723_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386081.101269942475483, 5860033.01989212166518 ] } }, +{ "type": "Feature", "properties": { "_index": 722, "bedlevel": 763.29998779296875, "branchid": "pipe_39_E0;pipe_39_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_724_generated", "shape": null, "area": 0.64, "streetlevel": 766.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 766.29998779296875, "distance_right": 4.0608894916904316e-07, "index_right": 731, "nodeid": "1386051.415039_5859913.714704", "id": "1386051.415039_5859913.714704", "name": "manhole_724_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386051.415038994979113, 5859913.714703594334424 ] } }, +{ "type": "Feature", "properties": { "_index": 723, "bedlevel": 763.29998779296875, "branchid": "pipe_39_E1;pipe_39_E2", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_725_generated", "shape": null, "area": 0.64, "streetlevel": 766.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 766.29998779296875, "distance_right": 3.9667516038273416e-07, "index_right": 732, "nodeid": "1386056.753748_5859949.432773", "id": "1386056.753748_5859949.432773", "name": "manhole_725_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386056.753747603856027, 5859949.43277302198112 ] } }, +{ "type": "Feature", "properties": { "_index": 724, "bedlevel": 763.29998779296875, "branchid": "pipe_39_E2;pipe_39_E3", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_726_generated", "shape": null, "area": 0.64, "streetlevel": 766.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 766.29998779296875, "distance_right": 4.4652043281523293e-07, "index_right": 733, "nodeid": "1386070.153564_5859990.873222", "id": "1386070.153564_5859990.873222", "name": "manhole_726_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386070.153564189793542, 5859990.873222404159606 ] } }, +{ "type": "Feature", "properties": { "_index": 726, "bedlevel": 753.5, "branchid": "pipe_40_E0;pipe_40_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_727_generated", "shape": null, "area": 0.64, "streetlevel": 756.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 756.5, "distance_right": 6.8990088841665868e-07, "index_right": 734, "nodeid": "1386095.159511_5860079.476792", "id": "1386095.159511_5860079.476792", "name": "manhole_727_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386095.159510504920036, 5860079.476792480796576 ] } }, +{ "type": "Feature", "properties": { "_index": 727, "bedlevel": 717.29998779296875, "branchid": "pipe_40_E1;pipe_40_E2", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_728_generated", "shape": null, "area": 0.64, "streetlevel": 720.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 720.29998779296875, "distance_right": 5.9386567370106793e-07, "index_right": 735, "nodeid": "1386119.249575_5860122.285581", "id": "1386119.249575_5860122.285581", "name": "manhole_728_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386119.249574675457552, 5860122.285581497475505 ] } }, +{ "type": "Feature", "properties": { "_index": 728, "bedlevel": 717.29998779296875, "branchid": "pipe_40_E2;pipe_40_E3", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_729_generated", "shape": null, "area": 0.64, "streetlevel": 720.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 720.29998779296875, "distance_right": 4.1965829506765982e-07, "index_right": 736, "nodeid": "1386143.813146_5860164.822059", "id": "1386143.813146_5860164.822059", "name": "manhole_729_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386143.813145637512207, 5860164.822058788500726 ] } }, +{ "type": "Feature", "properties": { "_index": 729, "bedlevel": 729.5, "branchid": "pipe_40_E3;pipe_40_E4", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_730_generated", "shape": null, "area": 0.64, "streetlevel": 732.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 732.5, "distance_right": 2.4941759242771704e-07, "index_right": 737, "nodeid": "1386168.698390_5860207.173543", "id": "1386168.698390_5860207.173543", "name": "manhole_730_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386168.698389830067754, 5860207.173543182201684 ] } }, +{ "type": "Feature", "properties": { "_index": 730, "bedlevel": 729.5, "branchid": "pipe_40_E4;pipe_40_E5", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_731_generated", "shape": null, "area": 0.64, "streetlevel": 732.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 732.5, "distance_right": 4.7271295433509584e-07, "index_right": 738, "nodeid": "1386190.960879_5860250.914159", "id": "1386190.960879_5860250.914159", "name": "manhole_731_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386190.960878706537187, 5860250.914158629253507 ] } }, +{ "type": "Feature", "properties": { "_index": 731, "bedlevel": 717.29998779296875, "branchid": "pipe_40_E5;pipe_40_E6", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_732_generated", "shape": null, "area": 0.64, "streetlevel": 720.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 720.29998779296875, "distance_right": 5.9534977694369198e-07, "index_right": 739, "nodeid": "1386212.013376_5860295.295641", "id": "1386212.013376_5860295.295641", "name": "manhole_732_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386212.013376480899751, 5860295.295640649273992 ] } }, +{ "type": "Feature", "properties": { "_index": 732, "bedlevel": 726.10003662109375, "branchid": "pipe_40_E6;pipe_40_E7", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_733_generated", "shape": null, "area": 0.64, "streetlevel": 729.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 729.10003662109375, "distance_right": 4.1705063981150445e-07, "index_right": 740, "nodeid": "1386233.065874_5860339.677123", "id": "1386233.065874_5860339.677123", "name": "manhole_733_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386233.065874255495146, 5860339.677122670225799 ] } }, +{ "type": "Feature", "properties": { "_index": 733, "bedlevel": 726.10003662109375, "branchid": "pipe_40_E7;pipe_40_E8", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_734_generated", "shape": null, "area": 0.64, "streetlevel": 729.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 729.10003662109375, "distance_right": 3.1158142785059036e-07, "index_right": 741, "nodeid": "1386254.118372_5860384.058605", "id": "1386254.118372_5860384.058605", "name": "manhole_734_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386254.118372030090541, 5860384.058604690246284 ] } }, +{ "type": "Feature", "properties": { "_index": 734, "bedlevel": 726.10003662109375, "branchid": "pipe_40_E8;pipe_40_E9", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_735_generated", "shape": null, "area": 0.64, "streetlevel": 729.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 729.10003662109375, "distance_right": 1.7018263719686392e-07, "index_right": 742, "nodeid": "1386270.265550_5860430.368607", "id": "1386270.265550_5860430.368607", "name": "manhole_735_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386270.265550139825791, 5860430.368606903590262 ] } }, +{ "type": "Feature", "properties": { "_index": 735, "bedlevel": 743.10003662109375, "branchid": "pipe_40_E9;pipe_40_E10", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_736_generated", "shape": null, "area": 0.64, "streetlevel": 746.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 746.10003662109375, "distance_right": 4.8813570520896638e-07, "index_right": 743, "nodeid": "1386284.690117_5860477.310511", "id": "1386284.690117_5860477.310511", "name": "manhole_736_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386284.690116602927446, 5860477.310510716401041 ] } }, +{ "type": "Feature", "properties": { "_index": 736, "bedlevel": 743.10003662109375, "branchid": "pipe_40_E10;pipe_40_E11", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_737_generated", "shape": null, "area": 0.64, "streetlevel": 746.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 746.10003662109375, "distance_right": 4.7960060831833522e-07, "index_right": 744, "nodeid": "1386295.943752_5860525.125564", "id": "1386295.943752_5860525.125564", "name": "manhole_737_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386295.943752367515117, 5860525.125563691370189 ] } }, +{ "type": "Feature", "properties": { "_index": 737, "bedlevel": 717.29998779296875, "branchid": "pipe_40_E11;pipe_40_E12", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_738_generated", "shape": null, "area": 0.64, "streetlevel": 720.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 720.29998779296875, "distance_right": 3.5954962138553505e-07, "index_right": 745, "nodeid": "1386307.197388_5860572.940617", "id": "1386307.197388_5860572.940617", "name": "manhole_738_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386307.197388132335618, 5860572.940616665408015 ] } }, +{ "type": "Feature", "properties": { "_index": 738, "bedlevel": 717.29998779296875, "branchid": "pipe_40_E12;pipe_40_E13", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_739_generated", "shape": null, "area": 0.64, "streetlevel": 720.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 720.29998779296875, "distance_right": 3.7399479825356605e-07, "index_right": 746, "nodeid": "1386318.451024_5860620.755670", "id": "1386318.451024_5860620.755670", "name": "manhole_739_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386318.451023896923289, 5860620.755669640377164 ] } }, +{ "type": "Feature", "properties": { "_index": 739, "bedlevel": 717.29998779296875, "branchid": "pipe_40_E13;pipe_40_E14", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_740_generated", "shape": null, "area": 0.64, "streetlevel": 720.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 720.29998779296875, "distance_right": 5.1309725242743082e-07, "index_right": 747, "nodeid": "1386329.704660_5860668.570723", "id": "1386329.704660_5860668.570723", "name": "manhole_740_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386329.704659661510959, 5860668.57072261441499 ] } }, +{ "type": "Feature", "properties": { "_index": 740, "bedlevel": 734.60003662109375, "branchid": "pipe_40_E14;pipe_40_E15", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_741_generated", "shape": null, "area": 0.64, "streetlevel": 737.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 737.60003662109375, "distance_right": 5.9196965643961131e-07, "index_right": 748, "nodeid": "1386340.958295_5860716.385776", "id": "1386340.958295_5860716.385776", "name": "manhole_741_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386340.95829542633146, 5860716.385775589384139 ] } }, +{ "type": "Feature", "properties": { "_index": 741, "bedlevel": 734.60003662109375, "branchid": "pipe_40_E15;pipe_40_E16", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_742_generated", "shape": null, "area": 0.64, "streetlevel": 737.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 737.60003662109375, "distance_right": 4.7669343638089868e-07, "index_right": 749, "nodeid": "1386352.211931_5860764.200829", "id": "1386352.211931_5860764.200829", "name": "manhole_742_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386352.211931190919131, 5860764.200828563421965 ] } }, +{ "type": "Feature", "properties": { "_index": 742, "bedlevel": 734.60003662109375, "branchid": "pipe_40_E16;pipe_40_E17", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_743_generated", "shape": null, "area": 0.64, "streetlevel": 737.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 737.60003662109375, "distance_right": 3.76122032946863e-07, "index_right": 750, "nodeid": "1386365.771370_5860811.365820", "id": "1386365.771370_5860811.365820", "name": "manhole_743_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386365.771370212780312, 5860811.365820310078561 ] } }, +{ "type": "Feature", "properties": { "_index": 743, "bedlevel": 741.5, "branchid": "pipe_40_E17;pipe_40_E18", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_744_generated", "shape": null, "area": 0.64, "streetlevel": 744.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 744.5, "distance_right": 6.6936522197239387e-07, "index_right": 751, "nodeid": "1386381.150273_5860858.017861", "id": "1386381.150273_5860858.017861", "name": "manhole_744_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386381.150273493025452, 5860858.017861452884972 ] } }, +{ "type": "Feature", "properties": { "_index": 744, "bedlevel": 721.29998779296875, "branchid": "pipe_40_E18;pipe_40_E19", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_745_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 3.9416955839349739e-07, "index_right": 752, "nodeid": "1386398.399082_5860903.951519", "id": "1386398.399082_5860903.951519", "name": "manhole_745_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386398.399082327727228, 5860903.951519219204783 ] } }, +{ "type": "Feature", "properties": { "_index": 745, "bedlevel": 721.29998779296875, "branchid": "pipe_40_E19;pipe_40_E20", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_746_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 5.567527440022547e-07, "index_right": 753, "nodeid": "1386418.211524_5860948.900276", "id": "1386418.211524_5860948.900276", "name": "manhole_746_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386418.211523674428463, 5860948.90027645137161 ] } }, +{ "type": "Feature", "properties": { "_index": 746, "bedlevel": 721.29998779296875, "branchid": "pipe_40_E20;pipe_40_E21", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_747_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 4.8463423027554962e-07, "index_right": 754, "nodeid": "1386441.678376_5860992.033180", "id": "1386441.678376_5860992.033180", "name": "manhole_747_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386441.67837643600069, 5860992.033180211670697 ] } }, +{ "type": "Feature", "properties": { "_index": 747, "bedlevel": 721.29998779296875, "branchid": "pipe_40_E21;pipe_40_E22", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_748_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 3.4573908100037007e-07, "index_right": 755, "nodeid": "1386465.536531_5861034.971649", "id": "1386465.536531_5861034.971649", "name": "manhole_748_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386465.536530936835334, 5861034.971648660488427 ] } }, +{ "type": "Feature", "properties": { "_index": 748, "bedlevel": 721.9000244140625, "branchid": "pipe_40_E22;pipe_40_E23", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_749_generated", "shape": null, "area": 0.64, "streetlevel": 724.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.9000244140625, "distance_right": 4.5085446316371647e-07, "index_right": 756, "nodeid": "1386489.394685_5861077.910117", "id": "1386489.394685_5861077.910117", "name": "manhole_749_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386489.394685437437147, 5861077.910117109306157 ] } }, +{ "type": "Feature", "properties": { "_index": 749, "bedlevel": 721.29998779296875, "branchid": "pipe_40_E23;pipe_40_E24", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_750_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 4.4666027024101134e-07, "index_right": 757, "nodeid": "1386513.252840_5861120.848586", "id": "1386513.252840_5861120.848586", "name": "manhole_750_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386513.252839938271791, 5861120.848585557192564 ] } }, +{ "type": "Feature", "properties": { "_index": 750, "bedlevel": 721.29998779296875, "branchid": "pipe_40_E24;pipe_40_E25", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_751_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 4.3892133490986504e-07, "index_right": 758, "nodeid": "1386537.110994_5861163.787054", "id": "1386537.110994_5861163.787054", "name": "manhole_751_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386537.110994438873604, 5861163.787054006010294 ] } }, +{ "type": "Feature", "properties": { "_index": 751, "bedlevel": 721.29998779296875, "branchid": "pipe_40_E25;pipe_40_E26", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_752_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 4.5846860528081458e-07, "index_right": 759, "nodeid": "1386560.969149_5861206.725522", "id": "1386560.969149_5861206.725522", "name": "manhole_752_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386560.969148939708248, 5861206.725522454828024 ] } }, +{ "type": "Feature", "properties": { "_index": 752, "bedlevel": 721.29998779296875, "branchid": "pipe_40_E26;pipe_40_E27", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_753_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 4.5081069418943963e-07, "index_right": 760, "nodeid": "1386584.827303_5861249.663991", "id": "1386584.827303_5861249.663991", "name": "manhole_753_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386584.827303440310061, 5861249.663990902714431 ] } }, +{ "type": "Feature", "properties": { "_index": 753, "bedlevel": 721.29998779296875, "branchid": "pipe_40_E27;pipe_40_E28", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_754_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 4.9127734780403708e-07, "index_right": 761, "nodeid": "1386607.696082_5861293.105181", "id": "1386607.696082_5861293.105181", "name": "manhole_754_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386607.696082097478211, 5861293.105181481689215 ] } }, +{ "type": "Feature", "properties": { "_index": 754, "bedlevel": 721.29998779296875, "branchid": "pipe_40_E28;pipe_40_E29", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_755_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 3.8526999555463843e-07, "index_right": 762, "nodeid": "1386626.999141_5861338.164891", "id": "1386626.999141_5861338.164891", "name": "manhole_755_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386626.999141034670174, 5861338.164890616200864 ] } }, +{ "type": "Feature", "properties": { "_index": 755, "bedlevel": 729.4000244140625, "branchid": "pipe_40_E29;pipe_40_E30", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_756_generated", "shape": null, "area": 0.64, "streetlevel": 732.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 732.4000244140625, "distance_right": 4.840163814950507e-07, "index_right": 763, "nodeid": "1386632.635545_5861386.242181", "id": "1386632.635545_5861386.242181", "name": "manhole_756_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386632.635544582502916, 5861386.242180755361915 ] } }, +{ "type": "Feature", "properties": { "_index": 756, "bedlevel": 729.4000244140625, "branchid": "pipe_40_E30;pipe_40_E31", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_757_generated", "shape": null, "area": 0.64, "streetlevel": 732.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 732.4000244140625, "distance_right": 2.6142848419208022e-07, "index_right": 764, "nodeid": "1386628.332881_5861435.174897", "id": "1386628.332881_5861435.174897", "name": "manhole_757_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386628.332881111185998, 5861435.174896763637662 ] } }, +{ "type": "Feature", "properties": { "_index": 757, "bedlevel": 729.4000244140625, "branchid": "pipe_40_E31;pipe_40_E32", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_758_generated", "shape": null, "area": 0.64, "streetlevel": 732.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 732.4000244140625, "distance_right": 4.2637953535945764e-07, "index_right": 765, "nodeid": "1386624.030218_5861484.107613", "id": "1386624.030218_5861484.107613", "name": "manhole_758_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386624.030217639869079, 5861484.107612771913409 ] } }, +{ "type": "Feature", "properties": { "_index": 758, "bedlevel": 755.79998779296875, "branchid": "pipe_40_E32;pipe_40_E33", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_759_generated", "shape": null, "area": 0.64, "streetlevel": 758.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 758.79998779296875, "distance_right": 2.7773094778815831e-07, "index_right": 766, "nodeid": "1386619.727554_5861533.040329", "id": "1386619.727554_5861533.040329", "name": "manhole_759_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386619.72755416855216, 5861533.040328779257834 ] } }, +{ "type": "Feature", "properties": { "_index": 759, "bedlevel": 755.79998779296875, "branchid": "pipe_40_E33;pipe_40_E34", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_760_generated", "shape": null, "area": 0.64, "streetlevel": 758.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 758.79998779296875, "distance_right": 1.3255917795466179e-07, "index_right": 767, "nodeid": "1386620.396810_5861581.843450", "id": "1386620.396810_5861581.843450", "name": "manhole_760_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386620.396809899713844, 5861581.843449912965298 ] } }, +{ "type": "Feature", "properties": { "_index": 760, "bedlevel": 755.79998779296875, "branchid": "pipe_40_E34;pipe_40_E35", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_761_generated", "shape": null, "area": 0.64, "streetlevel": 758.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 758.79998779296875, "distance_right": 3.3282772002277633e-07, "index_right": 768, "nodeid": "1386627.242797_5861630.485572", "id": "1386627.242797_5861630.485572", "name": "manhole_761_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386627.242796876933426, 5861630.485572309233248 ] } }, +{ "type": "Feature", "properties": { "_index": 761, "bedlevel": 774.9000244140625, "branchid": "pipe_40_E35;pipe_40_E36", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_762_generated", "shape": null, "area": 0.64, "streetlevel": 777.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 777.9000244140625, "distance_right": 5.4635113303875806e-07, "index_right": 769, "nodeid": "1386633.497010_5861679.177459", "id": "1386633.497010_5861679.177459", "name": "manhole_762_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386633.497009602142498, 5861679.177458625286818 ] } }, +{ "type": "Feature", "properties": { "_index": 762, "bedlevel": 774.9000244140625, "branchid": "pipe_40_E36;pipe_40_E37", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_763_generated", "shape": null, "area": 0.64, "streetlevel": 777.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 777.9000244140625, "distance_right": 5.846229101433154e-07, "index_right": 770, "nodeid": "1386633.587327_5861728.232038", "id": "1386633.587327_5861728.232038", "name": "manhole_763_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386633.587326586712152, 5861728.232037586160004 ] } }, +{ "type": "Feature", "properties": { "_index": 763, "bedlevel": 774.9000244140625, "branchid": "pipe_40_E37;pipe_40_E38", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_764_generated", "shape": null, "area": 0.64, "streetlevel": 777.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 777.9000244140625, "distance_right": 2.2543790250488301e-07, "index_right": 771, "nodeid": "1386628.569952_5861777.096642", "id": "1386628.569952_5861777.096642", "name": "manhole_764_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386628.569951781770214, 5861777.096641942858696 ] } }, +{ "type": "Feature", "properties": { "_index": 764, "bedlevel": 784.0, "branchid": "pipe_40_E38;pipe_41_E0", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_765_generated", "shape": null, "area": 0.64, "streetlevel": 787.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 787.0, "distance_right": 3.0078835670256984e-07, "index_right": 772, "nodeid": "1386623.552577_5861825.961246", "id": "1386623.552577_5861825.961246", "name": "manhole_765_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386623.552576976828277, 5861825.961246299557388 ] } }, +{ "type": "Feature", "properties": { "_index": 765, "bedlevel": 784.0, "branchid": "pipe_41_E0;pipe_41_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_766_generated", "shape": null, "area": 0.64, "streetlevel": 787.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 787.0, "distance_right": 3.86942464847858e-07, "index_right": 773, "nodeid": "1386622.452885_5861875.377416", "id": "1386622.452885_5861875.377416", "name": "manhole_766_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386622.452884682221338, 5861875.377415779046714 ] } }, +{ "type": "Feature", "properties": { "_index": 766, "bedlevel": 765.0, "branchid": "pipe_41_E1;pipe_41_E2", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_767_generated", "shape": null, "area": 0.64, "streetlevel": 768.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 768.0, "distance_right": 1.5812903614993457e-07, "index_right": 774, "nodeid": "1386630.050832_5861924.208797", "id": "1386630.050832_5861924.208797", "name": "manhole_767_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386630.050831846194342, 5861924.208797036670148 ] } }, +{ "type": "Feature", "properties": { "_index": 767, "bedlevel": 765.0, "branchid": "pipe_41_E2;pipe_41_E3", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_768_generated", "shape": null, "area": 0.64, "streetlevel": 768.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 768.0, "distance_right": 2.0956943835879417e-07, "index_right": 775, "nodeid": "1386645.112437_5861971.295392", "id": "1386645.112437_5861971.295392", "name": "manhole_768_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386645.112437101313844, 5861971.295391816645861 ] } }, +{ "type": "Feature", "properties": { "_index": 768, "bedlevel": 765.0, "branchid": "pipe_41_E3;pipe_41_E4", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_769_generated", "shape": null, "area": 0.64, "streetlevel": 768.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 768.0, "distance_right": 5.8255627545422018e-07, "index_right": 776, "nodeid": "1386663.826806_5862017.116110", "id": "1386663.826806_5862017.116110", "name": "manhole_769_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386663.826805545249954, 5862017.116109635680914 ] } }, +{ "type": "Feature", "properties": { "_index": 769, "bedlevel": 726.0, "branchid": "pipe_41_E4;pipe_41_E5", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_770_generated", "shape": null, "area": 0.64, "streetlevel": 729.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 729.0, "distance_right": 4.5554265962626818e-07, "index_right": 777, "nodeid": "1386682.541174_5862062.936827", "id": "1386682.541174_5862062.936827", "name": "manhole_770_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386682.541173989186063, 5862062.93682745564729 ] } }, +{ "type": "Feature", "properties": { "_index": 770, "bedlevel": 726.0, "branchid": "pipe_41_E5;pipe_41_E6", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_771_generated", "shape": null, "area": 0.64, "streetlevel": 729.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 729.0, "distance_right": 4.1193130229873742e-07, "index_right": 778, "nodeid": "1386700.357505_5862109.113540", "id": "1386700.357505_5862109.113540", "name": "manhole_771_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386700.357504795538262, 5862109.113540357910097 ] } }, +{ "type": "Feature", "properties": { "_index": 771, "bedlevel": 726.0, "branchid": "pipe_41_E6;pipe_41_E7", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_772_generated", "shape": null, "area": 0.64, "streetlevel": 729.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 729.0, "distance_right": 3.2735028015839139e-07, "index_right": 779, "nodeid": "1386718.120610_5862155.311353", "id": "1386718.120610_5862155.311353", "name": "manhole_772_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386718.120609947945923, 5862155.311352676711977 ] } }, +{ "type": "Feature", "properties": { "_index": 772, "bedlevel": 721.29998779296875, "branchid": "pipe_41_E7;pipe_41_E8", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_773_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 1.0018646052454545e-07, "index_right": 780, "nodeid": "1386735.883715_5862201.509165", "id": "1386735.883715_5862201.509165", "name": "manhole_773_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386735.883715100120753, 5862201.509164996445179 ] } }, +{ "type": "Feature", "properties": { "_index": 773, "bedlevel": 721.29998779296875, "branchid": "pipe_41_E8;pipe_41_E9", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_774_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 1.2663675617332469e-07, "index_right": 781, "nodeid": "1386757.522535_5862245.993861", "id": "1386757.522535_5862245.993861", "name": "manhole_774_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386757.522535112220794, 5862245.993861058726907 ] } }, +{ "type": "Feature", "properties": { "_index": 774, "bedlevel": 721.29998779296875, "branchid": "pipe_41_E9;pipe_41_E10", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_775_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 2.3017284626667885e-07, "index_right": 782, "nodeid": "1386779.730984_5862290.226774", "id": "1386779.730984_5862290.226774", "name": "manhole_775_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386779.73098383564502, 5862290.226773838512599 ] } }, +{ "type": "Feature", "properties": { "_index": 775, "bedlevel": 721.29998779296875, "branchid": "pipe_41_E10;pipe_41_E11", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_776_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 2.0776009455858673e-07, "index_right": 783, "nodeid": "1386802.545179_5862334.095373", "id": "1386802.545179_5862334.095373", "name": "manhole_776_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386802.545179207576439, 5862334.095372994430363 ] } }, +{ "type": "Feature", "properties": { "_index": 776, "bedlevel": 721.29998779296875, "branchid": "pipe_41_E11;pipe_41_E12", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_777_generated", "shape": null, "area": 0.64, "streetlevel": 724.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 724.29998779296875, "distance_right": 3.5309356282638562e-07, "index_right": 784, "nodeid": "1386831.207994_5862374.446443", "id": "1386831.207994_5862374.446443", "name": "manhole_777_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386831.207993831252679, 5862374.446442689746618 ] } }, +{ "type": "Feature", "properties": { "_index": 777, "bedlevel": 734.70001220703125, "branchid": "pipe_41_E12;pipe_41_E13", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_778_generated", "shape": null, "area": 0.64, "streetlevel": 737.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 737.70001220703125, "distance_right": 2.9095978348194408e-07, "index_right": 785, "nodeid": "1386859.988486_5862414.708454", "id": "1386859.988486_5862414.708454", "name": "manhole_778_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386859.988485741894692, 5862414.708453865721822 ] } }, +{ "type": "Feature", "properties": { "_index": 778, "bedlevel": 734.70001220703125, "branchid": "pipe_41_E13;pipe_41_E14", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_779_generated", "shape": null, "area": 0.64, "streetlevel": 737.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 737.70001220703125, "distance_right": 2.7843430015560495e-07, "index_right": 786, "nodeid": "1386891.035651_5862453.255040", "id": "1386891.035651_5862453.255040", "name": "manhole_779_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386891.035651177866384, 5862453.255039785988629 ] } }, +{ "type": "Feature", "properties": { "_index": 779, "bedlevel": 740.9000244140625, "branchid": "pipe_41_E14;pipe_41_E15", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_780_generated", "shape": null, "area": 0.64, "streetlevel": 743.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 743.9000244140625, "distance_right": 4.842933356581801e-07, "index_right": 787, "nodeid": "1386922.082817_5862491.801626", "id": "1386922.082817_5862491.801626", "name": "manhole_780_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386922.082816614070907, 5862491.801625707186759 ] } }, +{ "type": "Feature", "properties": { "_index": 780, "bedlevel": 753.0, "branchid": "pipe_41_E15;pipe_41_E16", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_781_generated", "shape": null, "area": 0.64, "streetlevel": 756.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 756.0, "distance_right": 3.7590837301943507e-07, "index_right": 788, "nodeid": "1386953.129982_5862530.348212", "id": "1386953.129982_5862530.348212", "name": "manhole_781_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386953.12998205027543, 5862530.348211627453566 ] } }, +{ "type": "Feature", "properties": { "_index": 781, "bedlevel": 753.0, "branchid": "pipe_41_E16;pipe_41_E17", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_782_generated", "shape": null, "area": 0.64, "streetlevel": 756.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 756.0, "distance_right": 6.6440650546458733e-07, "index_right": 789, "nodeid": "1386984.177147_5862568.894798", "id": "1386984.177147_5862568.894798", "name": "manhole_782_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1386984.177147486479953, 5862568.894797547720373 ] } }, +{ "type": "Feature", "properties": { "_index": 782, "bedlevel": 758.4000244140625, "branchid": "pipe_41_E17;pipe_41_E18", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_783_generated", "shape": null, "area": 0.64, "streetlevel": 761.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 761.4000244140625, "distance_right": 5.6406653307900537e-07, "index_right": 790, "nodeid": "1387010.831901_5862610.297833", "id": "1387010.831901_5862610.297833", "name": "manhole_783_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387010.83190148579888, 5862610.297833287157118 ] } }, +{ "type": "Feature", "properties": { "_index": 783, "bedlevel": 758.4000244140625, "branchid": "pipe_41_E18;pipe_41_E19", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_784_generated", "shape": null, "area": 0.64, "streetlevel": 761.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 761.4000244140625, "distance_right": 5.0755547669671581e-07, "index_right": 791, "nodeid": "1387033.474099_5862654.310294", "id": "1387033.474099_5862654.310294", "name": "manhole_784_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387033.474099110113457, 5862654.310293504968286 ] } }, +{ "type": "Feature", "properties": { "_index": 784, "bedlevel": 767.5, "branchid": "pipe_41_E19;pipe_41_E20", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_785_generated", "shape": null, "area": 0.64, "streetlevel": 770.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 770.5, "distance_right": 3.8351560851169947e-07, "index_right": 792, "nodeid": "1387056.116297_5862698.322754", "id": "1387056.116297_5862698.322754", "name": "manhole_785_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387056.116296734428033, 5862698.322753723710775 ] } }, +{ "type": "Feature", "properties": { "_index": 785, "bedlevel": 762.29998779296875, "branchid": "pipe_41_E20;pipe_41_E21", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_786_generated", "shape": null, "area": 0.64, "streetlevel": 765.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 765.29998779296875, "distance_right": 3.6340865905868276e-07, "index_right": 793, "nodeid": "1387078.758494_5862742.335214", "id": "1387078.758494_5862742.335214", "name": "manhole_786_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387078.75849435874261, 5862742.335213942453265 ] } }, +{ "type": "Feature", "properties": { "_index": 786, "bedlevel": 762.29998779296875, "branchid": "pipe_41_E21;pipe_41_E22", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_787_generated", "shape": null, "area": 0.64, "streetlevel": 765.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 765.29998779296875, "distance_right": 1.6201282395265412e-07, "index_right": 794, "nodeid": "1387101.400692_5862786.347674", "id": "1387101.400692_5862786.347674", "name": "manhole_787_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387101.400691983057186, 5862786.347674161195755 ] } }, +{ "type": "Feature", "properties": { "_index": 787, "bedlevel": 762.29998779296875, "branchid": "pipe_41_E22;pipe_41_E23", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_788_generated", "shape": null, "area": 0.64, "streetlevel": 765.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 765.29998779296875, "distance_right": 4.9157915962717621e-07, "index_right": 795, "nodeid": "1387124.783531_5862829.966972", "id": "1387124.783531_5862829.966972", "name": "manhole_788_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387124.783531384309754, 5862829.966971693560481 ] } }, +{ "type": "Feature", "properties": { "_index": 788, "bedlevel": 761.20001220703125, "branchid": "pipe_41_E23;pipe_41_E24", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_789_generated", "shape": null, "area": 0.64, "streetlevel": 764.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 764.20001220703125, "distance_right": 3.5598160791369735e-07, "index_right": 796, "nodeid": "1387148.551342_5862873.381911", "id": "1387148.551342_5862873.381911", "name": "manhole_789_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387148.551342260092497, 5862873.381910757161677 ] } }, +{ "type": "Feature", "properties": { "_index": 789, "bedlevel": 761.20001220703125, "branchid": "pipe_41_E24;pipe_41_E25", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_790_generated", "shape": null, "area": 0.64, "streetlevel": 764.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 764.20001220703125, "distance_right": 4.7576371253412377e-07, "index_right": 797, "nodeid": "1387176.029596_5862914.516765", "id": "1387176.029596_5862914.516765", "name": "manhole_790_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387176.029596295906231, 5862914.516764627769589 ] } }, +{ "type": "Feature", "properties": { "_index": 790, "bedlevel": 761.20001220703125, "branchid": "pipe_41_E25;pipe_41_E26", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_791_generated", "shape": null, "area": 0.64, "streetlevel": 764.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 764.20001220703125, "distance_right": 5.0580076725114359e-07, "index_right": 798, "nodeid": "1387204.050834_5862955.315436", "id": "1387204.050834_5862955.315436", "name": "manhole_791_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387204.050833505578339, 5862955.315435893833637 ] } }, +{ "type": "Feature", "properties": { "_index": 791, "bedlevel": 766.20001220703125, "branchid": "pipe_41_E26;pipe_41_E27", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_792_generated", "shape": null, "area": 0.64, "streetlevel": 769.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 769.20001220703125, "distance_right": 4.679884932996435e-07, "index_right": 799, "nodeid": "1387233.152246_5862995.351339", "id": "1387233.152246_5862995.351339", "name": "manhole_792_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387233.152246462181211, 5862995.351338926702738 ] } }, +{ "type": "Feature", "properties": { "_index": 792, "bedlevel": 769.70001220703125, "branchid": "pipe_41_E27;pipe_41_E28", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_793_generated", "shape": null, "area": 0.64, "streetlevel": 772.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 772.70001220703125, "distance_right": 4.2100416125757269e-07, "index_right": 800, "nodeid": "1387262.253659_5863035.387242", "id": "1387262.253659_5863035.387242", "name": "manhole_793_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387262.253659419016913, 5863035.387241959571838 ] } }, +{ "type": "Feature", "properties": { "_index": 793, "bedlevel": 769.70001220703125, "branchid": "pipe_41_E28;pipe_41_E29", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_794_generated", "shape": null, "area": 0.64, "streetlevel": 772.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 772.70001220703125, "distance_right": 2.2191985042402401e-07, "index_right": 801, "nodeid": "1387289.177212_5863076.714860", "id": "1387289.177212_5863076.714860", "name": "manhole_794_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387289.177211825968698, 5863076.714860137552023 ] } }, +{ "type": "Feature", "properties": { "_index": 794, "bedlevel": 769.70001220703125, "branchid": "pipe_41_E29;pipe_41_E30", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_795_generated", "shape": null, "area": 0.64, "streetlevel": 772.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 772.70001220703125, "distance_right": 3.2784018053457337e-07, "index_right": 802, "nodeid": "1387304.666786_5863123.392671", "id": "1387304.666786_5863123.392671", "name": "manhole_795_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387304.666786204557866, 5863123.392671256326139 ] } }, +{ "type": "Feature", "properties": { "_index": 795, "bedlevel": 759.0, "branchid": "pipe_41_E30;pipe_41_E31", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_796_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 5.8792503762199079e-07, "index_right": 803, "nodeid": "1387314.520281_5863171.895174", "id": "1387314.520281_5863171.895174", "name": "manhole_796_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387314.520281337434426, 5863171.895173518918455 ] } }, +{ "type": "Feature", "properties": { "_index": 796, "bedlevel": 774.10003662109375, "branchid": "pipe_41_E31;pipe_41_E32", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_797_generated", "shape": null, "area": 0.64, "streetlevel": 777.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 777.10003662109375, "distance_right": 4.4211253240860219e-07, "index_right": 804, "nodeid": "1387324.142221_5863220.446013", "id": "1387324.142221_5863220.446013", "name": "manhole_797_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387324.142220750683919, 5863220.446013364940882 ] } }, +{ "type": "Feature", "properties": { "_index": 797, "bedlevel": 777.4000244140625, "branchid": "pipe_41_E32;pipe_41_E33", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_798_generated", "shape": null, "area": 0.64, "streetlevel": 780.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 780.4000244140625, "distance_right": 2.666317529901308e-07, "index_right": 805, "nodeid": "1387333.764160_5863268.996853", "id": "1387333.764160_5863268.996853", "name": "manhole_798_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387333.764160163700581, 5863268.996853210031986 ] } }, +{ "type": "Feature", "properties": { "_index": 798, "bedlevel": 777.4000244140625, "branchid": "pipe_41_E33;pipe_41_E34", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_799_generated", "shape": null, "area": 0.64, "streetlevel": 780.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 780.4000244140625, "distance_right": 4.2683769428980457e-07, "index_right": 806, "nodeid": "1387343.386100_5863317.547693", "id": "1387343.386100_5863317.547693", "name": "manhole_799_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387343.386099576717243, 5863317.547693055123091 ] } }, +{ "type": "Feature", "properties": { "_index": 799, "bedlevel": 777.4000244140625, "branchid": "pipe_41_E34;pipe_41_E35", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_800_generated", "shape": null, "area": 0.64, "streetlevel": 780.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 780.4000244140625, "distance_right": 1.0017672039214415e-07, "index_right": 807, "nodeid": "1387353.008039_5863366.098533", "id": "1387353.008039_5863366.098533", "name": "manhole_800_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387353.008038989733905, 5863366.098532900214195 ] } }, +{ "type": "Feature", "properties": { "_index": 800, "bedlevel": 759.0, "branchid": "pipe_41_E35;pipe_41_E36", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_801_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 3.0672342309098305e-07, "index_right": 808, "nodeid": "1387364.066298_5863414.311535", "id": "1387364.066298_5863414.311535", "name": "manhole_801_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387364.066297837067395, 5863414.311534740030766 ] } }, +{ "type": "Feature", "properties": { "_index": 801, "bedlevel": 759.0, "branchid": "pipe_41_E36;pipe_41_E37", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_802_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 4.932537930056262e-07, "index_right": 809, "nodeid": "1387381.839410_5863460.427046", "id": "1387381.839410_5863460.427046", "name": "manhole_802_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387381.839409928303212, 5863460.427046488039196 ] } }, +{ "type": "Feature", "properties": { "_index": 802, "bedlevel": 759.0, "branchid": "pipe_41_E37;pipe_41_E38", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_803_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 1.9402170239574572e-07, "index_right": 810, "nodeid": "1387403.429579_5863504.961006", "id": "1387403.429579_5863504.961006", "name": "manhole_803_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387403.429578960640356, 5863504.96100580971688 ] } }, +{ "type": "Feature", "properties": { "_index": 803, "bedlevel": 759.0, "branchid": "pipe_41_E38;pipe_41_E39", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_804_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 2.8008674835213068e-07, "index_right": 811, "nodeid": "1387425.140453_5863549.440256", "id": "1387425.140453_5863549.440256", "name": "manhole_804_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387425.140452897874638, 5863549.440256260335445 ] } }, +{ "type": "Feature", "properties": { "_index": 804, "bedlevel": 759.0, "branchid": "pipe_41_E39;pipe_41_E40", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_805_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 3.3245607064712215e-07, "index_right": 812, "nodeid": "1387446.851327_5863593.919507", "id": "1387446.851327_5863593.919507", "name": "manhole_805_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387446.851326835108921, 5863593.91950671095401 ] } }, +{ "type": "Feature", "properties": { "_index": 805, "bedlevel": 759.0, "branchid": "pipe_41_E40;pipe_41_E41", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_806_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 4.0018657127822077e-07, "index_right": 813, "nodeid": "1387467.528696_5863638.888380", "id": "1387467.528696_5863638.888380", "name": "manhole_806_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387467.528695637593046, 5863638.888379830867052 ] } }, +{ "type": "Feature", "properties": { "_index": 806, "bedlevel": 771.5, "branchid": "pipe_41_E41;pipe_41_E42", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_807_generated", "shape": null, "area": 0.64, "streetlevel": 774.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 774.5, "distance_right": 2.3491677372957467e-08, "index_right": 814, "nodeid": "1387488.196078_5863683.861984", "id": "1387488.196078_5863683.861984", "name": "manhole_807_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387488.196078018052503, 5863683.861984014511108 ] } }, +{ "type": "Feature", "properties": { "_index": 807, "bedlevel": 759.0, "branchid": "pipe_41_E42;pipe_41_E43", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_808_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 4.8218551750434724e-07, "index_right": 815, "nodeid": "1387508.863468_5863728.835585", "id": "1387508.863468_5863728.835585", "name": "manhole_808_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387508.863468252588063, 5863728.835584589280188 ] } }, +{ "type": "Feature", "properties": { "_index": 808, "bedlevel": 759.0, "branchid": "pipe_41_E43;pipe_41_E44", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_809_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 1.1856933389495643e-07, "index_right": 816, "nodeid": "1387529.531309_5863773.808978", "id": "1387529.531309_5863773.808978", "name": "manhole_809_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387529.53130904212594, 5863773.808978110551834 ] } }, +{ "type": "Feature", "properties": { "_index": 809, "bedlevel": 759.0, "branchid": "pipe_41_E44;pipe_41_E45", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_810_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 4.2460196573060659e-07, "index_right": 817, "nodeid": "1387553.168003_5863817.173475", "id": "1387553.168003_5863817.173475", "name": "manhole_810_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387553.168002701364458, 5863817.17347530182451 ] } }, +{ "type": "Feature", "properties": { "_index": 810, "bedlevel": 759.0, "branchid": "pipe_41_E45;pipe_41_E46", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_811_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 3.185126609139896e-07, "index_right": 818, "nodeid": "1387579.562713_5863859.043334", "id": "1387579.562713_5863859.043334", "name": "manhole_811_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387579.562712850514799, 5863859.043333718553185 ] } }, +{ "type": "Feature", "properties": { "_index": 811, "bedlevel": 774.0, "branchid": "pipe_41_E46;pipe_41_E47", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_812_generated", "shape": null, "area": 0.64, "streetlevel": 777.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 777.0, "distance_right": 1.3597329523501825e-07, "index_right": 819, "nodeid": "1387605.957423_5863900.913192", "id": "1387605.957423_5863900.913192", "name": "manhole_812_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387605.957422999665141, 5863900.913192136213183 ] } }, +{ "type": "Feature", "properties": { "_index": 812, "bedlevel": 759.0, "branchid": "pipe_41_E47;pipe_41_E48", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_813_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 4.703326535743616e-07, "index_right": 820, "nodeid": "1387632.352133_5863942.783051", "id": "1387632.352133_5863942.783051", "name": "manhole_813_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387632.352133149048313, 5863942.783050553873181 ] } }, +{ "type": "Feature", "properties": { "_index": 813, "bedlevel": 759.0, "branchid": "pipe_41_E48;pipe_41_E49", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_814_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 2.9974130926166885e-07, "index_right": 821, "nodeid": "1387658.746843_5863984.652909", "id": "1387658.746843_5863984.652909", "name": "manhole_814_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387658.746843298198655, 5863984.652908970601857 ] } }, +{ "type": "Feature", "properties": { "_index": 814, "bedlevel": 759.0, "branchid": "pipe_41_E49;pipe_41_E50", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_815_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 4.8424206602011246e-07, "index_right": 822, "nodeid": "1387685.893106_5864026.029538", "id": "1387685.893106_5864026.029538", "name": "manhole_815_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387685.893106181640178, 5864026.029537551105022 ] } }, +{ "type": "Feature", "properties": { "_index": 815, "bedlevel": 759.0, "branchid": "pipe_41_E50;pipe_41_E51", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_816_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 1.1295166229046853e-07, "index_right": 823, "nodeid": "1387711.231137_5864068.427257", "id": "1387711.231137_5864068.427257", "name": "manhole_816_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387711.231136992340907, 5864068.42725711222738 ] } }, +{ "type": "Feature", "properties": { "_index": 816, "bedlevel": 759.0, "branchid": "pipe_41_E51;pipe_41_E52", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_817_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 4.1562063366879777e-07, "index_right": 824, "nodeid": "1387731.020947_5864113.414904", "id": "1387731.020947_5864113.414904", "name": "manhole_817_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387731.020947323646396, 5864113.414904261007905 ] } }, +{ "type": "Feature", "properties": { "_index": 817, "bedlevel": 759.0, "branchid": "pipe_41_E52;pipe_41_E53", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_818_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 5.0488384242805156e-07, "index_right": 825, "nodeid": "1387737.361907_5864162.342262", "id": "1387737.361907_5864162.342262", "name": "manhole_818_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387737.361907477490604, 5864162.342261835932732 ] } }, +{ "type": "Feature", "properties": { "_index": 818, "bedlevel": 759.0, "branchid": "pipe_41_E53;pipe_41_E54", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_819_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 3.9003768298900882e-07, "index_right": 826, "nodeid": "1387732.727566_5864211.475180", "id": "1387732.727566_5864211.475180", "name": "manhole_819_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387732.727565656881779, 5864211.475179814733565 ] } }, +{ "type": "Feature", "properties": { "_index": 819, "bedlevel": 759.0, "branchid": "pipe_41_E54;pipe_41_E55", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_820_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 5.2718950664228206e-07, "index_right": 827, "nodeid": "1387717.678849_5864258.627082", "id": "1387717.678849_5864258.627082", "name": "manhole_820_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387717.67884943424724, 5864258.627082298509777 ] } }, +{ "type": "Feature", "properties": { "_index": 820, "bedlevel": 759.0, "branchid": "pipe_41_E55;pipe_41_E56", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_821_generated", "shape": null, "area": 0.64, "streetlevel": 762.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 762.0, "distance_right": 2.4290664354722118e-07, "index_right": 828, "nodeid": "1387709.672104_5864307.231276", "id": "1387709.672104_5864307.231276", "name": "manhole_821_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387709.67210421175696, 5864307.23127611912787 ] } }, +{ "type": "Feature", "properties": { "_index": 821, "bedlevel": 765.0, "branchid": "pipe_41_E56;pipe_41_E57", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_822_generated", "shape": null, "area": 0.64, "streetlevel": 768.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 768.0, "distance_right": 1.5902605674469676e-07, "index_right": 829, "nodeid": "1387707.112881_5864356.660176", "id": "1387707.112881_5864356.660176", "name": "manhole_822_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387707.11288084089756, 5864356.66017600055784 ] } }, +{ "type": "Feature", "properties": { "_index": 822, "bedlevel": 765.0, "branchid": "pipe_41_E57;pipe_41_E58", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_823_generated", "shape": null, "area": 0.64, "streetlevel": 768.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 768.0, "distance_right": 1.7519326271547128e-07, "index_right": 830, "nodeid": "1387709.591798_5864406.012949", "id": "1387709.591798_5864406.012949", "name": "manhole_823_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387709.591797993984073, 5864406.012949175201356 ] } }, +{ "type": "Feature", "properties": { "_index": 823, "bedlevel": 765.0, "branchid": "pipe_41_E58;pipe_41_E59", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_824_generated", "shape": null, "area": 0.64, "streetlevel": 768.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 768.0, "distance_right": 3.1494439266847145e-07, "index_right": 831, "nodeid": "1387713.643261_5864455.341961", "id": "1387713.643261_5864455.341961", "name": "manhole_824_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387713.643261310644448, 5864455.341961052268744 ] } }, +{ "type": "Feature", "properties": { "_index": 824, "bedlevel": 774.20001220703125, "branchid": "pipe_41_E59;pipe_41_E60", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_825_generated", "shape": null, "area": 0.64, "streetlevel": 777.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 777.20001220703125, "distance_right": 3.3700013852472541e-07, "index_right": 832, "nodeid": "1387715.877522_5864504.642318", "id": "1387715.877522_5864504.642318", "name": "manhole_825_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387715.877521668095142, 5864504.642317942343652 ] } }, +{ "type": "Feature", "properties": { "_index": 825, "bedlevel": 774.20001220703125, "branchid": "pipe_41_E60;pipe_41_E61", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_826_generated", "shape": null, "area": 0.64, "streetlevel": 777.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 777.20001220703125, "distance_right": 4.8866509689768297e-07, "index_right": 833, "nodeid": "1387708.680233_5864553.426558", "id": "1387708.680233_5864553.426558", "name": "manhole_826_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387708.68023270717822, 5864553.426558391191065 ] } }, +{ "type": "Feature", "properties": { "_index": 826, "bedlevel": 774.20001220703125, "branchid": "pipe_41_E61;pipe_41_E62", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_827_generated", "shape": null, "area": 0.64, "streetlevel": 777.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 777.20001220703125, "distance_right": 3.4967976999271033e-07, "index_right": 834, "nodeid": "1387690.790251_5864599.575386", "id": "1387690.790251_5864599.575386", "name": "manhole_827_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387690.790250770282, 5864599.575386263430119 ] } }, +{ "type": "Feature", "properties": { "_index": 827, "bedlevel": 807.60003662109375, "branchid": "pipe_41_E62;pipe_41_E63", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_828_generated", "shape": null, "area": 0.64, "streetlevel": 810.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 810.60003662109375, "distance_right": 2.1553742732443595e-07, "index_right": 835, "nodeid": "1387672.900269_5864645.724214", "id": "1387672.900269_5864645.724214", "name": "manhole_828_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387672.900268833618611, 5864645.724214136600494 ] } }, +{ "type": "Feature", "properties": { "_index": 828, "bedlevel": 807.60003662109375, "branchid": "pipe_41_E63;pipe_41_E64", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_829_generated", "shape": null, "area": 0.64, "streetlevel": 810.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 810.60003662109375, "distance_right": 5.0501138359744414e-07, "index_right": 836, "nodeid": "1387659.931900_5864692.983886", "id": "1387659.931900_5864692.983886", "name": "manhole_829_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387659.931900478899479, 5864692.98388583958149 ] } }, +{ "type": "Feature", "properties": { "_index": 829, "bedlevel": 807.60003662109375, "branchid": "pipe_41_E64;pipe_41_E65", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_830_generated", "shape": null, "area": 0.64, "streetlevel": 810.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 810.60003662109375, "distance_right": 4.453007647556389e-07, "index_right": 837, "nodeid": "1387659.223570_5864742.029465", "id": "1387659.223570_5864742.029465", "name": "manhole_830_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387659.223570322152227, 5864742.029465307481587 ] } }, +{ "type": "Feature", "properties": { "_index": 830, "bedlevel": 806.60003662109375, "branchid": "pipe_41_E65;pipe_41_E66", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_831_generated", "shape": null, "area": 0.64, "streetlevel": 809.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 809.60003662109375, "distance_right": 4.9934199741603634e-07, "index_right": 838, "nodeid": "1387675.926897_5864788.273514", "id": "1387675.926897_5864788.273514", "name": "manhole_831_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387675.926896508783102, 5864788.273513910360634 ] } }, +{ "type": "Feature", "properties": { "_index": 831, "bedlevel": 771.10003662109375, "branchid": "pipe_41_E66;pipe_41_E67", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_832_generated", "shape": null, "area": 0.64, "streetlevel": 774.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 774.10003662109375, "distance_right": 4.9261335667974956e-07, "index_right": 839, "nodeid": "1387702.296292_5864830.159320", "id": "1387702.296292_5864830.159320", "name": "manhole_832_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387702.296291569946334, 5864830.159320239908993 ] } }, +{ "type": "Feature", "properties": { "_index": 832, "bedlevel": 771.10003662109375, "branchid": "pipe_41_E67;pipe_41_E68", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_833_generated", "shape": null, "area": 0.64, "streetlevel": 774.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 774.10003662109375, "distance_right": 5.6685196386871291e-07, "index_right": 840, "nodeid": "1387728.665687_5864872.045127", "id": "1387728.665687_5864872.045127", "name": "manhole_833_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387728.665686630876735, 5864872.045126569457352 ] } }, +{ "type": "Feature", "properties": { "_index": 833, "bedlevel": 779.5, "branchid": "pipe_41_E68;pipe_41_E69", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_834_generated", "shape": null, "area": 0.64, "streetlevel": 782.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 782.5, "distance_right": 3.260812906289786e-07, "index_right": 841, "nodeid": "1387751.608185_5864915.528789", "id": "1387751.608185_5864915.528789", "name": "manhole_834_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387751.608185108983889, 5864915.528788692317903 ] } }, +{ "type": "Feature", "properties": { "_index": 834, "bedlevel": 779.5, "branchid": "pipe_41_E69;pipe_41_E70", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_835_generated", "shape": null, "area": 0.64, "streetlevel": 782.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 782.5, "distance_right": 5.9259639011965048e-07, "index_right": 842, "nodeid": "1387766.741665_5864962.653555", "id": "1387766.741665_5864962.653555", "name": "manhole_835_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387766.741664502769709, 5864962.653554677963257 ] } }, +{ "type": "Feature", "properties": { "_index": 835, "bedlevel": 779.5, "branchid": "pipe_41_E70;pipe_41_E71", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_836_generated", "shape": null, "area": 0.64, "streetlevel": 782.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 782.5, "distance_right": 4.9711278093853967e-07, "index_right": 843, "nodeid": "1387778.991920_5865010.246724", "id": "1387778.991920_5865010.246724", "name": "manhole_836_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387778.99191950308159, 5865010.246724016033113 ] } }, +{ "type": "Feature", "properties": { "_index": 836, "bedlevel": 817.20001220703125, "branchid": "pipe_41_E71;pipe_41_E72", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_837_generated", "shape": null, "area": 0.64, "streetlevel": 820.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 820.20001220703125, "distance_right": 2.7262320916715243e-07, "index_right": 844, "nodeid": "1387779.554608_5865059.738634", "id": "1387779.554608_5865059.738634", "name": "manhole_837_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387779.554608268430457, 5865059.738633952103555 ] } }, +{ "type": "Feature", "properties": { "_index": 837, "bedlevel": 817.20001220703125, "branchid": "pipe_41_E72;pipe_41_E73", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_838_generated", "shape": null, "area": 0.64, "streetlevel": 820.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 820.20001220703125, "distance_right": 1.176384747423801e-07, "index_right": 845, "nodeid": "1387780.117297_5865109.230544", "id": "1387780.117297_5865109.230544", "name": "manhole_838_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387780.117297033779323, 5865109.230543887242675 ] } }, +{ "type": "Feature", "properties": { "_index": 838, "bedlevel": 831.60003662109375, "branchid": "pipe_41_E73;pipe_41_E74", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_839_generated", "shape": null, "area": 0.64, "streetlevel": 834.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 834.60003662109375, "distance_right": 2.5451201057427246e-07, "index_right": 846, "nodeid": "1387782.917817_5865158.566991", "id": "1387782.917817_5865158.566991", "name": "manhole_839_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387782.917817069217563, 5865158.566991245374084 ] } }, +{ "type": "Feature", "properties": { "_index": 839, "bedlevel": 806.60003662109375, "branchid": "pipe_41_E74;pipe_41_E75", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_840_generated", "shape": null, "area": 0.64, "streetlevel": 809.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 809.60003662109375, "distance_right": 3.8381515451147322e-07, "index_right": 847, "nodeid": "1387789.203932_5865207.661294", "id": "1387789.203932_5865207.661294", "name": "manhole_840_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387789.203931836877018, 5865207.661293652839959 ] } }, +{ "type": "Feature", "properties": { "_index": 840, "bedlevel": 806.60003662109375, "branchid": "pipe_41_E75;pipe_41_E76", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_841_generated", "shape": null, "area": 0.64, "streetlevel": 809.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 809.60003662109375, "distance_right": 3.9995425409532255e-07, "index_right": 848, "nodeid": "1387795.490047_5865256.755596", "id": "1387795.490047_5865256.755596", "name": "manhole_841_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387795.490046604769304, 5865256.755596060305834 ] } }, +{ "type": "Feature", "properties": { "_index": 841, "bedlevel": 808.60003662109375, "branchid": "pipe_41_E76;pipe_41_E77", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_842_generated", "shape": null, "area": 0.64, "streetlevel": 811.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 811.60003662109375, "distance_right": 4.8361564557877265e-07, "index_right": 849, "nodeid": "1387804.549935_5865305.332480", "id": "1387804.549935_5865305.332480", "name": "manhole_842_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387804.549934879876673, 5865305.332479531876743 ] } }, +{ "type": "Feature", "properties": { "_index": 842, "bedlevel": 808.60003662109375, "branchid": "pipe_41_E77;pipe_41_E78", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_843_generated", "shape": null, "area": 0.64, "streetlevel": 811.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 811.60003662109375, "distance_right": 3.9649035137181816e-07, "index_right": 850, "nodeid": "1387816.386747_5865353.391356", "id": "1387816.386747_5865353.391356", "name": "manhole_843_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387816.386747075244784, 5865353.391356389038265 ] } }, +{ "type": "Feature", "properties": { "_index": 843, "bedlevel": 808.60003662109375, "branchid": "pipe_41_E78;pipe_41_E79", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_844_generated", "shape": null, "area": 0.64, "streetlevel": 811.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 811.60003662109375, "distance_right": 3.6575204182979905e-07, "index_right": 851, "nodeid": "1387828.223559_5865401.450233", "id": "1387828.223559_5865401.450233", "name": "manhole_844_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387828.223559270845726, 5865401.450233246199787 ] } }, +{ "type": "Feature", "properties": { "_index": 844, "bedlevel": 799.5, "branchid": "pipe_41_E79;pipe_41_E80", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_845_generated", "shape": null, "area": 0.64, "streetlevel": 802.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 802.5, "distance_right": 5.0071148835204541e-07, "index_right": 852, "nodeid": "1387842.966275_5865448.679594", "id": "1387842.966275_5865448.679594", "name": "manhole_845_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387842.96627543354407, 5865448.679594250395894 ] } }, +{ "type": "Feature", "properties": { "_index": 845, "bedlevel": 799.5, "branchid": "pipe_41_E80;pipe_41_E81", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_846_generated", "shape": null, "area": 0.64, "streetlevel": 802.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 802.5, "distance_right": 2.0659636486342148e-07, "index_right": 853, "nodeid": "1387858.283513_5865495.744953", "id": "1387858.283513_5865495.744953", "name": "manhole_846_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387858.283513206522912, 5865495.744953005574644 ] } }, +{ "type": "Feature", "properties": { "_index": 846, "bedlevel": 799.5, "branchid": "pipe_41_E81;pipe_41_E82", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_847_generated", "shape": null, "area": 0.64, "streetlevel": 802.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 802.5, "distance_right": 4.9802795784708347e-07, "index_right": 854, "nodeid": "1387872.788358_5865543.026506", "id": "1387872.788358_5865543.026506", "name": "manhole_847_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387872.788357679266483, 5865543.026506381109357 ] } }, +{ "type": "Feature", "properties": { "_index": 847, "bedlevel": 775.20001220703125, "branchid": "pipe_41_E82;pipe_41_E83", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_848_generated", "shape": null, "area": 0.64, "streetlevel": 778.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 778.20001220703125, "distance_right": 3.0259537908334364e-07, "index_right": 855, "nodeid": "1387882.890575_5865591.479690", "id": "1387882.890575_5865591.479690", "name": "manhole_848_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387882.890574953285977, 5865591.479689701460302 ] } }, +{ "type": "Feature", "properties": { "_index": 848, "bedlevel": 775.20001220703125, "branchid": "pipe_41_E83;pipe_41_E84", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_849_generated", "shape": null, "area": 0.64, "streetlevel": 778.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 778.20001220703125, "distance_right": 2.2833932818058066e-07, "index_right": 856, "nodeid": "1387892.992792_5865639.932873", "id": "1387892.992792_5865639.932873", "name": "manhole_849_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387892.992792227305472, 5865639.932873022742569 ] } }, +{ "type": "Feature", "properties": { "_index": 849, "bedlevel": 775.20001220703125, "branchid": "pipe_41_E84;pipe_41_E85", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_850_generated", "shape": null, "area": 0.64, "streetlevel": 778.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 778.20001220703125, "distance_right": 6.0513342729627048e-07, "index_right": 857, "nodeid": "1387903.095010_5865688.386056", "id": "1387903.095010_5865688.386056", "name": "manhole_850_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387903.095009501324967, 5865688.386056343093514 ] } }, +{ "type": "Feature", "properties": { "_index": 850, "bedlevel": 791.70001220703125, "branchid": "pipe_41_E85;pipe_50_E0;pipe_51_E12", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_851_generated", "shape": null, "area": 0.64, "streetlevel": 794.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 794.70001220703125, "distance_right": 4.0437267150492186e-07, "index_right": 858, "nodeid": "1387913.197227_5865736.839240", "id": "1387913.197227_5865736.839240", "name": "manhole_851_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387913.197226775344461, 5865736.839239663444459 ] } }, +{ "type": "Feature", "properties": { "_index": 851, "bedlevel": 827.9000244140625, "branchid": "pipe_42_E0;pipe_43_E1;pipe_44_E0", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_852_generated", "shape": null, "area": 0.64, "streetlevel": 830.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 830.9000244140625, "distance_right": 5.215972352701414e-07, "index_right": 859, "nodeid": "1387767.438602_5866395.894651", "id": "1387767.438602_5866395.894651", "name": "manhole_852_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387767.438602478476241, 5866395.894650792703032 ] } }, +{ "type": "Feature", "properties": { "_index": 851, "bedlevel": 827.9000244140625, "branchid": "pipe_42_E0;pipe_42_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_853_generated", "shape": null, "area": 0.64, "streetlevel": 830.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 830.9000244140625, "distance_right": 1.7080837506054717e-07, "index_right": 860, "nodeid": "1387758.181959_5866444.388787", "id": "1387758.181959_5866444.388787", "name": "manhole_853_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387758.181959156645462, 5866444.388786932453513 ] } }, +{ "type": "Feature", "properties": { "_index": 852, "bedlevel": 827.9000244140625, "branchid": "pipe_42_E1;pipe_42_E2", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_854_generated", "shape": null, "area": 0.64, "streetlevel": 830.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 830.9000244140625, "distance_right": 1.7976697036433568e-07, "index_right": 861, "nodeid": "1387748.925316_5866492.882923", "id": "1387748.925316_5866492.882923", "name": "manhole_854_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387748.925315835047513, 5866492.882923071272671 ] } }, +{ "type": "Feature", "properties": { "_index": 853, "bedlevel": 813.5, "branchid": "pipe_42_E2;pipe_42_E3", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_855_generated", "shape": null, "area": 0.64, "streetlevel": 816.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 816.5, "distance_right": 5.3076935757696028e-07, "index_right": 862, "nodeid": "1387739.668673_5866541.377059", "id": "1387739.668673_5866541.377059", "name": "manhole_855_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387739.668672513216734, 5866541.377059211023152 ] } }, +{ "type": "Feature", "properties": { "_index": 854, "bedlevel": 813.5, "branchid": "pipe_42_E3;pipe_42_E4", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_856_generated", "shape": null, "area": 0.64, "streetlevel": 816.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 816.5, "distance_right": 3.9917691783746745e-07, "index_right": 863, "nodeid": "1387730.412029_5866589.871195", "id": "1387730.412029_5866589.871195", "name": "manhole_856_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387730.412029191618785, 5866589.87119534984231 ] } }, +{ "type": "Feature", "properties": { "_index": 855, "bedlevel": 813.10003662109375, "branchid": "pipe_42_E4;pipe_42_E5", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_857_generated", "shape": null, "area": 0.64, "streetlevel": 816.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 816.10003662109375, "distance_right": 5.0687060002795753e-07, "index_right": 864, "nodeid": "1387721.155386_5866638.365331", "id": "1387721.155386_5866638.365331", "name": "manhole_857_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387721.155385869788006, 5866638.365331489592791 ] } }, +{ "type": "Feature", "properties": { "_index": 856, "bedlevel": 813.10003662109375, "branchid": "pipe_42_E5;pipe_42_E6", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_858_generated", "shape": null, "area": 0.64, "streetlevel": 816.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 816.10003662109375, "distance_right": 5.9584928216719691e-07, "index_right": 865, "nodeid": "1387711.868743_5866686.853722", "id": "1387711.868743_5866686.853722", "name": "manhole_858_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387711.868742506252602, 5866686.853722332976758 ] } }, +{ "type": "Feature", "properties": { "_index": 857, "bedlevel": 813.10003662109375, "branchid": "pipe_42_E6;pipe_42_E7", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_859_generated", "shape": null, "area": 0.64, "streetlevel": 816.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 816.10003662109375, "distance_right": 5.7928339006193113e-07, "index_right": 866, "nodeid": "1387702.553355_5866735.336608", "id": "1387702.553355_5866735.336608", "name": "manhole_859_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387702.553355348296463, 5866735.336608462966979 ] } }, +{ "type": "Feature", "properties": { "_index": 858, "bedlevel": 799.4000244140625, "branchid": "pipe_42_E7", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_860_generated", "shape": null, "area": 0.64, "streetlevel": 802.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 802.4000244140625, "distance_right": 4.9781434926194598e-07, "index_right": 867, "nodeid": "1387692.161796_5866783.420620", "id": "1387692.161796_5866783.420620", "name": "manhole_860_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387692.161796326050535, 5866783.420620376244187 ] } }, +{ "type": "Feature", "properties": { "_index": 859, "bedlevel": 803.20001220703125, "branchid": "pipe_43_E0;pipe_45_E3;pipe_46_E4", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_861_generated", "shape": null, "area": 0.64, "streetlevel": 806.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 806.20001220703125, "distance_right": 5.3089394760884435e-07, "index_right": 868, "nodeid": "1387809.534625_5866309.639252", "id": "1387809.534625_5866309.639252", "name": "manhole_861_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387809.534624515566975, 5866309.639251782558858 ] } }, +{ "type": "Feature", "properties": { "_index": 859, "bedlevel": 803.20001220703125, "branchid": "pipe_43_E0;pipe_43_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_862_generated", "shape": null, "area": 0.64, "streetlevel": 806.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 806.20001220703125, "distance_right": 5.7391922453984659e-07, "index_right": 869, "nodeid": "1387788.486613_5866352.766951", "id": "1387788.486613_5866352.766951", "name": "manhole_862_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387788.486613497138023, 5866352.766951287165284 ] } }, +{ "type": "Feature", "properties": { "_index": 861, "bedlevel": 837.10003662109375, "branchid": "pipe_44_E0;pipe_44_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_863_generated", "shape": null, "area": 0.64, "streetlevel": 840.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 840.10003662109375, "distance_right": 4.8732610625475058e-07, "index_right": 870, "nodeid": "1387774.733068_5866351.644692", "id": "1387774.733068_5866351.644692", "name": "manhole_863_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387774.73306847945787, 5866351.644692087545991 ] } }, +{ "type": "Feature", "properties": { "_index": 862, "bedlevel": 803.20001220703125, "branchid": "pipe_44_E1;pipe_44_E2", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_864_generated", "shape": null, "area": 0.64, "streetlevel": 806.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 806.20001220703125, "distance_right": 2.4437958040221395e-07, "index_right": 871, "nodeid": "1387787.219046_5866308.756402", "id": "1387787.219046_5866308.756402", "name": "manhole_864_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387787.219046234386042, 5866308.756401930935681 ] } }, +{ "type": "Feature", "properties": { "_index": 863, "bedlevel": 803.20001220703125, "branchid": "pipe_44_E2;pipe_44_E3", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_865_generated", "shape": null, "area": 0.64, "streetlevel": 806.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 806.20001220703125, "distance_right": 3.3154241596590628e-07, "index_right": 872, "nodeid": "1387802.581936_5866266.622690", "id": "1387802.581936_5866266.622690", "name": "manhole_865_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387802.581935805035755, 5866266.622689731419086 ] } }, +{ "type": "Feature", "properties": { "_index": 864, "bedlevel": 824.70001220703125, "branchid": "pipe_44_E3;pipe_44_E4", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_866_generated", "shape": null, "area": 0.64, "streetlevel": 827.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 827.70001220703125, "distance_right": 4.2553696916372962e-07, "index_right": 873, "nodeid": "1387818.989884_5866224.886323", "id": "1387818.989884_5866224.886323", "name": "manhole_866_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387818.989883717847988, 5866224.886323318816721 ] } }, +{ "type": "Feature", "properties": { "_index": 865, "bedlevel": 824.70001220703125, "branchid": "pipe_44_E4;pipe_44_E5", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_867_generated", "shape": null, "area": 0.64, "streetlevel": 827.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 827.70001220703125, "distance_right": 2.2789743614175487e-07, "index_right": 874, "nodeid": "1387838.767448_5866184.784888", "id": "1387838.767448_5866184.784888", "name": "manhole_867_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387838.767447788733989, 5866184.784887914545834 ] } }, +{ "type": "Feature", "properties": { "_index": 866, "bedlevel": 824.70001220703125, "branchid": "pipe_44_E5;pipe_44_E6", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_868_generated", "shape": null, "area": 0.64, "streetlevel": 827.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 827.70001220703125, "distance_right": 5.9797237451900057e-07, "index_right": 875, "nodeid": "1387862.375428_5866146.679680", "id": "1387862.375428_5866146.679680", "name": "manhole_868_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387862.375427621416748, 5866146.679679537191987 ] } }, +{ "type": "Feature", "properties": { "_index": 867, "bedlevel": 800.9000244140625, "branchid": "pipe_44_E6;pipe_44_E7", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_869_generated", "shape": null, "area": 0.64, "streetlevel": 803.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 803.9000244140625, "distance_right": 3.6638230381293925e-07, "index_right": 876, "nodeid": "1387890.316308_5866111.904927", "id": "1387890.316308_5866111.904927", "name": "manhole_869_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387890.316308293025941, 5866111.904927220195532 ] } }, +{ "type": "Feature", "properties": { "_index": 868, "bedlevel": 800.9000244140625, "branchid": "pipe_44_E7;pipe_46_E0;pipe_47_E5;pipe_48_E0", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_870_generated", "shape": null, "area": 0.64, "streetlevel": 803.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 803.9000244140625, "distance_right": 3.1534587877498962e-07, "index_right": 877, "nodeid": "1387932.086586_5866099.149365", "id": "1387932.086586_5866099.149365", "name": "manhole_870_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387932.086585889104754, 5866099.149365295656025 ] } }, +{ "type": "Feature", "properties": { "_index": 869, "bedlevel": 800.9000244140625, "branchid": "pipe_45_E0", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_871_generated", "shape": null, "area": 0.64, "streetlevel": 803.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 803.9000244140625, "distance_right": 6.266084733821659e-07, "index_right": 878, "nodeid": "1387931.614703_5866170.542120", "id": "1387931.614703_5866170.542120", "name": "manhole_871_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387931.614702571649104, 5866170.542120457626879 ] } }, +{ "type": "Feature", "properties": { "_index": 869, "bedlevel": 800.9000244140625, "branchid": "pipe_45_E0;pipe_45_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_872_generated", "shape": null, "area": 0.64, "streetlevel": 803.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 803.9000244140625, "distance_right": 5.3846575384340826e-07, "index_right": 879, "nodeid": "1387899.497388_5866203.806989", "id": "1387899.497388_5866203.806989", "name": "manhole_872_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387899.497387683717534, 5866203.806988564319909 ] } }, +{ "type": "Feature", "properties": { "_index": 870, "bedlevel": 803.20001220703125, "branchid": "pipe_45_E1;pipe_45_E2", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_873_generated", "shape": null, "area": 0.64, "streetlevel": 806.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 806.20001220703125, "distance_right": 3.6531595428320365e-07, "index_right": 880, "nodeid": "1387869.509800_5866239.084410", "id": "1387869.509800_5866239.084410", "name": "manhole_873_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387869.509799961000681, 5866239.084409636445343 ] } }, +{ "type": "Feature", "properties": { "_index": 871, "bedlevel": 803.20001220703125, "branchid": "pipe_45_E2;pipe_45_E3", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_874_generated", "shape": null, "area": 0.64, "streetlevel": 806.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 806.20001220703125, "distance_right": 3.7571919273733843e-07, "index_right": 881, "nodeid": "1387839.522212_5866274.361831", "id": "1387839.522212_5866274.361831", "name": "manhole_874_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387839.522212238283828, 5866274.361830709502101 ] } }, +{ "type": "Feature", "properties": { "_index": 873, "bedlevel": 800.9000244140625, "branchid": "pipe_46_E0;pipe_46_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_875_generated", "shape": null, "area": 0.64, "streetlevel": 803.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 803.9000244140625, "distance_right": 6.1718976969024423e-07, "index_right": 882, "nodeid": "1387908.367354_5866141.903963", "id": "1387908.367354_5866141.903963", "name": "manhole_875_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387908.367353544337675, 5866141.903963415883482 ] } }, +{ "type": "Feature", "properties": { "_index": 874, "bedlevel": 800.9000244140625, "branchid": "pipe_46_E1;pipe_46_E2", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_876_generated", "shape": null, "area": 0.64, "streetlevel": 803.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 803.9000244140625, "distance_right": 4.9858174847585437e-07, "index_right": 883, "nodeid": "1387876.955023_5866179.987773", "id": "1387876.955023_5866179.987773", "name": "manhole_876_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387876.955022902460769, 5866179.987773489207029 ] } }, +{ "type": "Feature", "properties": { "_index": 875, "bedlevel": 824.70001220703125, "branchid": "pipe_46_E2;pipe_46_E3", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_877_generated", "shape": null, "area": 0.64, "streetlevel": 827.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 827.70001220703125, "distance_right": 1.876529768744179e-07, "index_right": 884, "nodeid": "1387847.458594_5866219.470103", "id": "1387847.458594_5866219.470103", "name": "manhole_877_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387847.458594153402373, 5866219.470102892257273 ] } }, +{ "type": "Feature", "properties": { "_index": 876, "bedlevel": 803.20001220703125, "branchid": "pipe_46_E3;pipe_46_E4", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_878_generated", "shape": null, "area": 0.64, "streetlevel": 806.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 806.20001220703125, "distance_right": 4.6156036966779148e-07, "index_right": 885, "nodeid": "1387823.639856_5866262.662998", "id": "1387823.639856_5866262.662998", "name": "manhole_878_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387823.639855962945148, 5866262.662997540086508 ] } }, +{ "type": "Feature", "properties": { "_index": 878, "bedlevel": 801.4000244140625, "branchid": "pipe_47_E0", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_879_generated", "shape": null, "area": 0.64, "streetlevel": 804.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 804.4000244140625, "distance_right": 2.7377250423463006e-07, "index_right": 886, "nodeid": "1387940.443674_5865845.093255", "id": "1387940.443674_5865845.093255", "name": "manhole_879_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387940.443674022099003, 5865845.093254727311432 ] } }, +{ "type": "Feature", "properties": { "_index": 878, "bedlevel": 801.4000244140625, "branchid": "pipe_47_E0;pipe_47_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_880_generated", "shape": null, "area": 0.64, "streetlevel": 804.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 804.4000244140625, "distance_right": 3.2059452282998279e-07, "index_right": 887, "nodeid": "1387943.318034_5865887.628140", "id": "1387943.318034_5865887.628140", "name": "manhole_880_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387943.318034203490242, 5865887.628139751963317 ] } }, +{ "type": "Feature", "properties": { "_index": 879, "bedlevel": 801.4000244140625, "branchid": "pipe_47_E1;pipe_47_E2", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_881_generated", "shape": null, "area": 0.64, "streetlevel": 804.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 804.4000244140625, "distance_right": 3.9845922374459836e-07, "index_right": 888, "nodeid": "1387946.009428_5865930.175073", "id": "1387946.009428_5865930.175073", "name": "manhole_881_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387946.009428307646886, 5865930.175072746351361 ] } }, +{ "type": "Feature", "properties": { "_index": 880, "bedlevel": 813.70001220703125, "branchid": "pipe_47_E2;pipe_47_E3", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_882_generated", "shape": null, "area": 0.64, "streetlevel": 816.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 816.70001220703125, "distance_right": 4.8718698089721897e-07, "index_right": 889, "nodeid": "1387948.700822_5865972.722006", "id": "1387948.700822_5865972.722006", "name": "manhole_882_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387948.700822412036359, 5865972.722005739808083 ] } }, +{ "type": "Feature", "properties": { "_index": 881, "bedlevel": 813.70001220703125, "branchid": "pipe_47_E3;pipe_47_E4", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_883_generated", "shape": null, "area": 0.64, "streetlevel": 816.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 816.70001220703125, "distance_right": 5.8533091283838573e-07, "index_right": 890, "nodeid": "1387944.872251_5866015.105106", "id": "1387944.872251_5866015.105106", "name": "manhole_883_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387944.872250664513558, 5866015.105105520226061 ] } }, +{ "type": "Feature", "properties": { "_index": 882, "bedlevel": 813.70001220703125, "branchid": "pipe_47_E4;pipe_47_E5", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_884_generated", "shape": null, "area": 0.64, "streetlevel": 816.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 816.70001220703125, "distance_right": 1.8278199108301624e-07, "index_right": 891, "nodeid": "1387940.047370_5866057.463170", "id": "1387940.047370_5866057.463170", "name": "manhole_884_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387940.047370131826028, 5866057.463170127011836 ] } }, +{ "type": "Feature", "properties": { "_index": 884, "bedlevel": 783.29998779296875, "branchid": "pipe_48_E0", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_885_generated", "shape": null, "area": 0.64, "streetlevel": 786.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 786.29998779296875, "distance_right": 5.3234291644079913e-07, "index_right": 892, "nodeid": "1387975.279995_5866107.425722", "id": "1387975.279995_5866107.425722", "name": "manhole_885_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387975.279995472636074, 5866107.425722245126963 ] } }, +{ "type": "Feature", "properties": { "_index": 885, "bedlevel": 906.5, "branchid": "pipe_49_E125", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_886_generated", "shape": null, "area": 0.64, "streetlevel": 909.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 909.5, "distance_right": 2.3433279429140186e-07, "index_right": 893, "nodeid": "1392926.966795_5866808.501405", "id": "1392926.966795_5866808.501405", "name": "manhole_886_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392926.966794768813998, 5866808.501405037939548 ] } }, +{ "type": "Feature", "properties": { "_index": 885, "bedlevel": 907.4000244140625, "branchid": "pipe_49_E125;pipe_49_E126", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_887_generated", "shape": null, "area": 0.64, "streetlevel": 910.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 910.4000244140625, "distance_right": 2.711877368400116e-07, "index_right": 894, "nodeid": "1392879.417932_5866793.491589", "id": "1392879.417932_5866793.491589", "name": "manhole_887_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392879.417931769276038, 5866793.491589142940938 ] } }, +{ "type": "Feature", "properties": { "_index": 886, "bedlevel": 907.4000244140625, "branchid": "pipe_49_E126;pipe_49_E127", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_888_generated", "shape": null, "area": 0.64, "streetlevel": 910.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 910.4000244140625, "distance_right": 3.3822343619387493e-07, "index_right": 895, "nodeid": "1392831.869069_5866778.481773", "id": "1392831.869069_5866778.481773", "name": "manhole_888_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392831.869068769738078, 5866778.481773247942328 ] } }, +{ "type": "Feature", "properties": { "_index": 887, "bedlevel": 862.0, "branchid": "pipe_49_E127;pipe_49_E128", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_889_generated", "shape": null, "area": 0.64, "streetlevel": 865.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 865.0, "distance_right": 4.2118703056337554e-07, "index_right": 896, "nodeid": "1392784.320206_5866763.471957", "id": "1392784.320206_5866763.471957", "name": "manhole_889_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392784.320205770200118, 5866763.471957352943718 ] } }, +{ "type": "Feature", "properties": { "_index": 888, "bedlevel": 862.0, "branchid": "pipe_49_E128;pipe_49_E129", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_890_generated", "shape": null, "area": 0.64, "streetlevel": 865.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 865.0, "distance_right": 5.1250356341054922e-07, "index_right": 897, "nodeid": "1392736.771343_5866748.462141", "id": "1392736.771343_5866748.462141", "name": "manhole_890_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392736.771342770429328, 5866748.462141457945108 ] } }, +{ "type": "Feature", "properties": { "_index": 889, "bedlevel": 875.4000244140625, "branchid": "pipe_49_E129;pipe_49_E130", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_891_generated", "shape": null, "area": 0.64, "streetlevel": 878.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 878.4000244140625, "distance_right": 4.9322917410243842e-07, "index_right": 898, "nodeid": "1392689.222480_5866733.452326", "id": "1392689.222480_5866733.452326", "name": "manhole_891_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392689.222479770891368, 5866733.452325562946498 ] } }, +{ "type": "Feature", "properties": { "_index": 890, "bedlevel": 875.4000244140625, "branchid": "pipe_49_E130;pipe_49_E131", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_892_generated", "shape": null, "area": 0.64, "streetlevel": 878.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 878.4000244140625, "distance_right": 4.035102166412638e-07, "index_right": 899, "nodeid": "1392641.673617_5866718.442510", "id": "1392641.673617_5866718.442510", "name": "manhole_892_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392641.673616771353409, 5866718.442509667947888 ] } }, +{ "type": "Feature", "properties": { "_index": 891, "bedlevel": 901.9000244140625, "branchid": "pipe_49_E131;pipe_49_E132", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_893_generated", "shape": null, "area": 0.64, "streetlevel": 904.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 904.9000244140625, "distance_right": 3.2137241883713538e-07, "index_right": 900, "nodeid": "1392594.124754_5866703.432694", "id": "1392594.124754_5866703.432694", "name": "manhole_893_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392594.124753771815449, 5866703.432693773880601 ] } }, +{ "type": "Feature", "properties": { "_index": 892, "bedlevel": 901.9000244140625, "branchid": "pipe_49_E132;pipe_49_E133", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_894_generated", "shape": null, "area": 0.64, "streetlevel": 904.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 904.9000244140625, "distance_right": 2.5789438712268496e-07, "index_right": 901, "nodeid": "1392546.575891_5866688.422878", "id": "1392546.575891_5866688.422878", "name": "manhole_894_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392546.575890772277489, 5866688.422877878881991 ] } }, +{ "type": "Feature", "properties": { "_index": 893, "bedlevel": 928.5, "branchid": "pipe_49_E133;pipe_49_E134", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_895_generated", "shape": null, "area": 0.64, "streetlevel": 931.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 931.5, "distance_right": 2.2779358194461109e-07, "index_right": 902, "nodeid": "1392499.027028_5866673.413062", "id": "1392499.027028_5866673.413062", "name": "manhole_895_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392499.02702777273953, 5866673.413061983883381 ] } }, +{ "type": "Feature", "properties": { "_index": 894, "bedlevel": 928.5, "branchid": "pipe_49_E134;pipe_49_E135", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_896_generated", "shape": null, "area": 0.64, "streetlevel": 931.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 931.5, "distance_right": 2.434250781957115e-07, "index_right": 903, "nodeid": "1392451.478165_5866658.403246", "id": "1392451.478165_5866658.403246", "name": "manhole_896_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392451.47816477320157, 5866658.403246088884771 ] } }, +{ "type": "Feature", "properties": { "_index": 895, "bedlevel": 923.29998779296875, "branchid": "pipe_49_E135;pipe_49_E136", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_897_generated", "shape": null, "area": 0.64, "streetlevel": 926.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 926.29998779296875, "distance_right": 2.9789659531254724e-07, "index_right": 904, "nodeid": "1392403.929302_5866643.393430", "id": "1392403.929302_5866643.393430", "name": "manhole_897_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392403.92930177366361, 5866643.393430193886161 ] } }, +{ "type": "Feature", "properties": { "_index": 896, "bedlevel": 846.79998779296875, "branchid": "pipe_49_E136;pipe_49_E137", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_898_generated", "shape": null, "area": 0.64, "streetlevel": 849.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 849.79998779296875, "distance_right": 3.7467334045624815e-07, "index_right": 905, "nodeid": "1392356.380439_5866628.383614", "id": "1392356.380439_5866628.383614", "name": "manhole_898_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392356.380438774125651, 5866628.383614298887551 ] } }, +{ "type": "Feature", "properties": { "_index": 897, "bedlevel": 872.20001220703125, "branchid": "pipe_49_E137;pipe_49_E138", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_899_generated", "shape": null, "area": 0.64, "streetlevel": 875.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 875.20001220703125, "distance_right": 4.6278392403377259e-07, "index_right": 906, "nodeid": "1392308.831576_5866613.373798", "id": "1392308.831576_5866613.373798", "name": "manhole_899_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392308.831575774587691, 5866613.373798403888941 ] } }, +{ "type": "Feature", "properties": { "_index": 898, "bedlevel": 872.20001220703125, "branchid": "pipe_49_E138;pipe_49_E139", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_900_generated", "shape": null, "area": 0.64, "streetlevel": 875.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 875.20001220703125, "distance_right": 5.3904050343464332e-07, "index_right": 907, "nodeid": "1392261.282713_5866598.363983", "id": "1392261.282713_5866598.363983", "name": "manhole_900_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392261.282712775049731, 5866598.363982509821653 ] } }, +{ "type": "Feature", "properties": { "_index": 899, "bedlevel": 925.10003662109375, "branchid": "pipe_49_E139;pipe_49_E140", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_901_generated", "shape": null, "area": 0.64, "streetlevel": 928.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 928.10003662109375, "distance_right": 4.461385093761408e-07, "index_right": 908, "nodeid": "1392213.733850_5866583.354167", "id": "1392213.733850_5866583.354167", "name": "manhole_901_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392213.733849775511771, 5866583.354166614823043 ] } }, +{ "type": "Feature", "properties": { "_index": 900, "bedlevel": 925.10003662109375, "branchid": "pipe_49_E140;pipe_49_E141", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_902_generated", "shape": null, "area": 0.64, "streetlevel": 928.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 928.10003662109375, "distance_right": 3.5882065240057058e-07, "index_right": 909, "nodeid": "1392166.184987_5866568.344351", "id": "1392166.184987_5866568.344351", "name": "manhole_902_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392166.184986775973812, 5866568.344350719824433 ] } }, +{ "type": "Feature", "properties": { "_index": 901, "bedlevel": 933.79998779296875, "branchid": "pipe_49_E141;pipe_49_E142", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_903_generated", "shape": null, "area": 0.64, "streetlevel": 936.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 936.79998779296875, "distance_right": 5.0133714651316256e-07, "index_right": 910, "nodeid": "1392119.234378_5866551.590171", "id": "1392119.234378_5866551.590171", "name": "manhole_903_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392119.234377897810191, 5866551.59017149079591 ] } }, +{ "type": "Feature", "properties": { "_index": 902, "bedlevel": 933.79998779296875, "branchid": "pipe_49_E142;pipe_49_E143", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_904_generated", "shape": null, "area": 0.64, "streetlevel": 936.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 936.79998779296875, "distance_right": 3.4515468306535673e-07, "index_right": 911, "nodeid": "1392072.481987_5866534.258036", "id": "1392072.481987_5866534.258036", "name": "manhole_904_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392072.481987217208371, 5866534.25803626794368 ] } }, +{ "type": "Feature", "properties": { "_index": 903, "bedlevel": 926.79998779296875, "branchid": "pipe_49_E143;pipe_49_E144", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_905_generated", "shape": null, "area": 0.64, "streetlevel": 929.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 929.79998779296875, "distance_right": 4.651642196257067e-07, "index_right": 912, "nodeid": "1392025.729597_5866516.925901", "id": "1392025.729597_5866516.925901", "name": "manhole_905_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1392025.729596536839381, 5866516.925901044160128 ] } }, +{ "type": "Feature", "properties": { "_index": 904, "bedlevel": 889.29998779296875, "branchid": "pipe_49_E144;pipe_49_E145", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_906_generated", "shape": null, "area": 0.64, "streetlevel": 892.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 892.29998779296875, "distance_right": 2.29953709160046e-07, "index_right": 913, "nodeid": "1391978.977206_5866499.593766", "id": "1391978.977206_5866499.593766", "name": "manhole_906_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391978.977205856470391, 5866499.593765820376575 ] } }, +{ "type": "Feature", "properties": { "_index": 905, "bedlevel": 908.4000244140625, "branchid": "pipe_49_E145;pipe_49_E146", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_907_generated", "shape": null, "area": 0.64, "streetlevel": 911.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 911.4000244140625, "distance_right": 4.3991124339150539e-07, "index_right": 914, "nodeid": "1391932.224815_5866482.261631", "id": "1391932.224815_5866482.261631", "name": "manhole_907_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391932.224815175868571, 5866482.261630596593022 ] } }, +{ "type": "Feature", "properties": { "_index": 906, "bedlevel": 908.4000244140625, "branchid": "pipe_49_E146;pipe_49_E147", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_908_generated", "shape": null, "area": 0.64, "streetlevel": 911.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 911.4000244140625, "distance_right": 6.1988875341513863e-07, "index_right": 915, "nodeid": "1391885.472424_5866464.929495", "id": "1391885.472424_5866464.929495", "name": "manhole_908_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391885.472424495499581, 5866464.92949537280947 ] } }, +{ "type": "Feature", "properties": { "_index": 907, "bedlevel": 930.20001220703125, "branchid": "pipe_49_E147;pipe_49_E148", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_909_generated", "shape": null, "area": 0.64, "streetlevel": 933.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 933.20001220703125, "distance_right": 2.3821214812358952e-07, "index_right": 916, "nodeid": "1391838.720034_5866447.597360", "id": "1391838.720034_5866447.597360", "name": "manhole_909_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391838.720033814897761, 5866447.59736014995724 ] } }, +{ "type": "Feature", "properties": { "_index": 908, "bedlevel": 930.20001220703125, "branchid": "pipe_49_E148;pipe_49_E149", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_910_generated", "shape": null, "area": 0.64, "streetlevel": 933.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 933.20001220703125, "distance_right": 1.5337514315044009e-07, "index_right": 917, "nodeid": "1391791.967643_5866430.265225", "id": "1391791.967643_5866430.265225", "name": "manhole_910_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391791.967643134528771, 5866430.265224926173687 ] } }, +{ "type": "Feature", "properties": { "_index": 909, "bedlevel": 936.4000244140625, "branchid": "pipe_49_E149;pipe_49_E150", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_911_generated", "shape": null, "area": 0.64, "streetlevel": 939.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 939.4000244140625, "distance_right": 5.4309463265053459e-07, "index_right": 918, "nodeid": "1391745.215252_5866412.933090", "id": "1391745.215252_5866412.933090", "name": "manhole_911_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391745.215252453926951, 5866412.933089702390134 ] } }, +{ "type": "Feature", "properties": { "_index": 910, "bedlevel": 936.4000244140625, "branchid": "pipe_49_E150;pipe_49_E151", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_912_generated", "shape": null, "area": 0.64, "streetlevel": 939.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 939.4000244140625, "distance_right": 5.2959964469147424e-07, "index_right": 919, "nodeid": "1391698.462862_5866395.600954", "id": "1391698.462862_5866395.600954", "name": "manhole_912_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391698.462861773557961, 5866395.600954478606582 ] } }, +{ "type": "Feature", "properties": { "_index": 911, "bedlevel": 949.70001220703125, "branchid": "pipe_49_E151;pipe_49_E152", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_913_generated", "shape": null, "area": 0.64, "streetlevel": 952.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 952.70001220703125, "distance_right": 2.7156648052421829e-07, "index_right": 920, "nodeid": "1391651.710471_5866378.268819", "id": "1391651.710471_5866378.268819", "name": "manhole_913_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391651.710471092956141, 5866378.268819254823029 ] } }, +{ "type": "Feature", "properties": { "_index": 912, "bedlevel": 886.4000244140625, "branchid": "pipe_49_E152;pipe_49_E153", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_914_generated", "shape": null, "area": 0.64, "streetlevel": 889.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 889.4000244140625, "distance_right": 4.1371902379653219e-07, "index_right": 921, "nodeid": "1391604.958080_5866360.936684", "id": "1391604.958080_5866360.936684", "name": "manhole_914_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391604.958080412587151, 5866360.936684031039476 ] } }, +{ "type": "Feature", "properties": { "_index": 913, "bedlevel": 845.70001220703125, "branchid": "pipe_49_E153;pipe_49_E154", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_915_generated", "shape": null, "area": 0.64, "streetlevel": 848.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 848.70001220703125, "distance_right": 3.293937330443308e-07, "index_right": 922, "nodeid": "1391558.205690_5866343.604549", "id": "1391558.205690_5866343.604549", "name": "manhole_915_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391558.205689732218161, 5866343.604548808187246 ] } }, +{ "type": "Feature", "properties": { "_index": 914, "bedlevel": 845.70001220703125, "branchid": "pipe_49_E154;pipe_49_E155", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_916_generated", "shape": null, "area": 0.64, "streetlevel": 848.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 848.70001220703125, "distance_right": 4.1857355203971027e-07, "index_right": 923, "nodeid": "1391511.453299_5866326.272414", "id": "1391511.453299_5866326.272414", "name": "manhole_916_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391511.453299051616341, 5866326.272413584403694 ] } }, +{ "type": "Feature", "properties": { "_index": 915, "bedlevel": 843.0, "branchid": "pipe_49_E155;pipe_49_E156", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_917_generated", "shape": null, "area": 0.64, "streetlevel": 846.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 846.0, "distance_right": 5.173421456765862e-07, "index_right": 924, "nodeid": "1391464.700908_5866308.940278", "id": "1391464.700908_5866308.940278", "name": "manhole_917_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391464.700908371247351, 5866308.940278360620141 ] } }, +{ "type": "Feature", "properties": { "_index": 916, "bedlevel": 843.0, "branchid": "pipe_49_E156;pipe_49_E157", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_918_generated", "shape": null, "area": 0.64, "streetlevel": 846.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 846.0, "distance_right": 3.3836509315063795e-07, "index_right": 925, "nodeid": "1391417.948518_5866291.608143", "id": "1391417.948518_5866291.608143", "name": "manhole_918_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391417.948517690645531, 5866291.608143136836588 ] } }, +{ "type": "Feature", "properties": { "_index": 917, "bedlevel": 846.9000244140625, "branchid": "pipe_49_E157;pipe_49_E158", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_919_generated", "shape": null, "area": 0.64, "streetlevel": 849.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 849.9000244140625, "distance_right": 8.7216755512678289e-08, "index_right": 926, "nodeid": "1391371.196127_5866274.276008", "id": "1391371.196127_5866274.276008", "name": "manhole_919_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391371.196127010276541, 5866274.276007913053036 ] } }, +{ "type": "Feature", "properties": { "_index": 918, "bedlevel": 846.9000244140625, "branchid": "pipe_49_E158;pipe_49_E159", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_920_generated", "shape": null, "area": 0.64, "streetlevel": 849.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 849.9000244140625, "distance_right": 4.5390732579378692e-07, "index_right": 927, "nodeid": "1391321.986833_5866269.550852", "id": "1391321.986833_5866269.550852", "name": "manhole_920_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391321.986832652939484, 5866269.550851707346737 ] } }, +{ "type": "Feature", "properties": { "_index": 919, "bedlevel": 892.70001220703125, "branchid": "pipe_49_E159;pipe_49_E160", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_921_generated", "shape": null, "area": 0.64, "streetlevel": 895.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 895.70001220703125, "distance_right": 3.7289003346476757e-07, "index_right": 928, "nodeid": "1391272.147465_5866268.058759", "id": "1391272.147465_5866268.058759", "name": "manhole_921_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391272.147464629728347, 5866268.058758955448866 ] } }, +{ "type": "Feature", "properties": { "_index": 920, "bedlevel": 892.70001220703125, "branchid": "pipe_49_E160;pipe_49_E161", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_922_generated", "shape": null, "area": 0.64, "streetlevel": 895.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 895.70001220703125, "distance_right": 4.43839029083394e-07, "index_right": 929, "nodeid": "1391222.308097_5866266.566666", "id": "1391222.308097_5866266.566666", "name": "manhole_922_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391222.30809660628438, 5866266.566666204482317 ] } }, +{ "type": "Feature", "properties": { "_index": 921, "bedlevel": 929.0, "branchid": "pipe_49_E161;pipe_49_E162", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_923_generated", "shape": null, "area": 0.64, "streetlevel": 932.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 932.0, "distance_right": 6.1558942756283069e-07, "index_right": 930, "nodeid": "1391172.468729_5866265.074573", "id": "1391172.468729_5866265.074573", "name": "manhole_923_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391172.468728582840413, 5866265.074573452584445 ] } }, +{ "type": "Feature", "properties": { "_index": 922, "bedlevel": 929.0, "branchid": "pipe_49_E162;pipe_49_E163", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_924_generated", "shape": null, "area": 0.64, "streetlevel": 932.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 932.0, "distance_right": 5.3218673253055169e-07, "index_right": 931, "nodeid": "1391122.629361_5866263.582481", "id": "1391122.629361_5866263.582481", "name": "manhole_924_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391122.629360559629276, 5866263.582480700686574 ] } }, +{ "type": "Feature", "properties": { "_index": 923, "bedlevel": 912.20001220703125, "branchid": "pipe_49_E163;pipe_49_E164", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_925_generated", "shape": null, "area": 0.64, "streetlevel": 915.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 915.20001220703125, "distance_right": 4.6651731725205036e-07, "index_right": 932, "nodeid": "1391072.789993_5866262.090388", "id": "1391072.789993_5866262.090388", "name": "manhole_925_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391072.789992536185309, 5866262.090387949720025 ] } }, +{ "type": "Feature", "properties": { "_index": 924, "bedlevel": 877.70001220703125, "branchid": "pipe_49_E164;pipe_49_E165", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_926_generated", "shape": null, "area": 0.64, "streetlevel": 880.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 880.70001220703125, "distance_right": 5.2579289086766228e-07, "index_right": 933, "nodeid": "1391022.950625_5866260.598295", "id": "1391022.950625_5866260.598295", "name": "manhole_926_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1391022.950624512741342, 5866260.598295197822154 ] } }, +{ "type": "Feature", "properties": { "_index": 925, "bedlevel": 877.70001220703125, "branchid": "pipe_49_E165;pipe_49_E166", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_927_generated", "shape": null, "area": 0.64, "streetlevel": 880.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 880.70001220703125, "distance_right": 6.6238845009442494e-07, "index_right": 934, "nodeid": "1390973.111256_5866259.106202", "id": "1390973.111256_5866259.106202", "name": "manhole_927_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390973.111256489530206, 5866259.106202445924282 ] } }, +{ "type": "Feature", "properties": { "_index": 926, "bedlevel": 886.4000244140625, "branchid": "pipe_49_E166;pipe_49_E167", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_928_generated", "shape": null, "area": 0.64, "streetlevel": 889.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 889.4000244140625, "distance_right": 5.573047437679622e-07, "index_right": 935, "nodeid": "1390923.271888_5866257.614110", "id": "1390923.271888_5866257.614110", "name": "manhole_928_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390923.271888466086239, 5866257.614109694957733 ] } }, +{ "type": "Feature", "properties": { "_index": 927, "bedlevel": 886.4000244140625, "branchid": "pipe_49_E167;pipe_49_E168", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_929_generated", "shape": null, "area": 0.64, "streetlevel": 889.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 889.4000244140625, "distance_right": 4.462420842811324e-07, "index_right": 936, "nodeid": "1390873.432520_5866256.122017", "id": "1390873.432520_5866256.122017", "name": "manhole_929_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390873.432520442642272, 5866256.122016943059862 ] } }, +{ "type": "Feature", "properties": { "_index": 928, "bedlevel": 932.79998779296875, "branchid": "pipe_49_E168;pipe_49_E169", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_930_generated", "shape": null, "area": 0.64, "streetlevel": 935.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 935.79998779296875, "distance_right": 4.6053406929521989e-07, "index_right": 937, "nodeid": "1390823.593152_5866254.629924", "id": "1390823.593152_5866254.629924", "name": "manhole_930_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390823.593152419198304, 5866254.62992419116199 ] } }, +{ "type": "Feature", "properties": { "_index": 929, "bedlevel": 932.79998779296875, "branchid": "pipe_49_E169;pipe_49_E170", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_931_generated", "shape": null, "area": 0.64, "streetlevel": 935.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 935.79998779296875, "distance_right": 5.9237281907764308e-07, "index_right": 938, "nodeid": "1390773.753784_5866253.137831", "id": "1390773.753784_5866253.137831", "name": "manhole_931_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390773.753784395987168, 5866253.137831440195441 ] } }, +{ "type": "Feature", "properties": { "_index": 930, "bedlevel": 954.79998779296875, "branchid": "pipe_49_E170;pipe_49_E171", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_932_generated", "shape": null, "area": 0.64, "streetlevel": 957.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 957.79998779296875, "distance_right": 4.8591928251911668e-07, "index_right": 939, "nodeid": "1390723.914416_5866251.645739", "id": "1390723.914416_5866251.645739", "name": "manhole_932_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390723.914416372543201, 5866251.64573868829757 ] } }, +{ "type": "Feature", "properties": { "_index": 931, "bedlevel": 954.79998779296875, "branchid": "pipe_49_E171;pipe_49_E172", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_933_generated", "shape": null, "area": 0.64, "streetlevel": 957.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 957.79998779296875, "distance_right": 3.5471234679006232e-07, "index_right": 940, "nodeid": "1390674.075048_5866250.153646", "id": "1390674.075048_5866250.153646", "name": "manhole_933_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390674.075048349099234, 5866250.153645936399698 ] } }, +{ "type": "Feature", "properties": { "_index": 932, "bedlevel": 954.0, "branchid": "pipe_49_E172;pipe_49_E173", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_934_generated", "shape": null, "area": 0.64, "streetlevel": 957.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 957.0, "distance_right": 3.7496693866214152e-07, "index_right": 941, "nodeid": "1390624.235680_5866248.661553", "id": "1390624.235680_5866248.661553", "name": "manhole_934_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390624.235680325888097, 5866248.661553185433149 ] } }, +{ "type": "Feature", "properties": { "_index": 933, "bedlevel": 954.0, "branchid": "pipe_49_E173;pipe_49_E174", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_935_generated", "shape": null, "area": 0.64, "streetlevel": 957.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 957.0, "distance_right": 5.2898676455779151e-07, "index_right": 942, "nodeid": "1390574.396312_5866247.169460", "id": "1390574.396312_5866247.169460", "name": "manhole_935_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390574.39631230244413, 5866247.169460433535278 ] } }, +{ "type": "Feature", "properties": { "_index": 934, "bedlevel": 961.5, "branchid": "pipe_49_E174;pipe_49_E175", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_936_generated", "shape": null, "area": 0.64, "streetlevel": 964.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 964.5, "distance_right": 4.2338240759397399e-07, "index_right": 943, "nodeid": "1390524.556944_5866245.677368", "id": "1390524.556944_5866245.677368", "name": "manhole_936_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390524.556944279000163, 5866245.677367681637406 ] } }, +{ "type": "Feature", "properties": { "_index": 935, "bedlevel": 961.5, "branchid": "pipe_49_E175;pipe_49_E176", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_937_generated", "shape": null, "area": 0.64, "streetlevel": 964.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 964.5, "distance_right": 2.6499942694981953e-07, "index_right": 944, "nodeid": "1390474.717576_5866244.185275", "id": "1390474.717576_5866244.185275", "name": "manhole_937_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390474.717576255789027, 5866244.185274930670857 ] } }, +{ "type": "Feature", "properties": { "_index": 936, "bedlevel": 945.5, "branchid": "pipe_49_E176;pipe_49_E177", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_938_generated", "shape": null, "area": 0.64, "streetlevel": 948.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 948.5, "distance_right": 2.9320284469871218e-07, "index_right": 945, "nodeid": "1390424.878208_5866242.693182", "id": "1390424.878208_5866242.693182", "name": "manhole_938_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390424.87820823234506, 5866242.693182178772986 ] } }, +{ "type": "Feature", "properties": { "_index": 937, "bedlevel": 967.10003662109375, "branchid": "pipe_49_E177;pipe_49_E178", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_939_generated", "shape": null, "area": 0.64, "streetlevel": 970.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 970.10003662109375, "distance_right": 4.7493074115861244e-07, "index_right": 946, "nodeid": "1390375.038840_5866241.201089", "id": "1390375.038840_5866241.201089", "name": "manhole_939_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390375.038840208901092, 5866241.201089426875114 ] } }, +{ "type": "Feature", "properties": { "_index": 938, "bedlevel": 967.10003662109375, "branchid": "pipe_49_E178;pipe_49_E179", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_940_generated", "shape": null, "area": 0.64, "streetlevel": 970.10003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 970.10003662109375, "distance_right": 3.7358023225235111e-07, "index_right": 947, "nodeid": "1390325.199472_5866239.708997", "id": "1390325.199472_5866239.708997", "name": "manhole_940_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390325.199472185689956, 5866239.708996675908566 ] } }, +{ "type": "Feature", "properties": { "_index": 939, "bedlevel": 972.4000244140625, "branchid": "pipe_49_E179;pipe_49_E180", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_941_generated", "shape": null, "area": 0.64, "streetlevel": 975.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 975.4000244140625, "distance_right": 1.7935411616933843e-07, "index_right": 948, "nodeid": "1390275.360104_5866238.216904", "id": "1390275.360104_5866238.216904", "name": "manhole_941_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390275.360104162245989, 5866238.216903924010694 ] } }, +{ "type": "Feature", "properties": { "_index": 940, "bedlevel": 972.4000244140625, "branchid": "pipe_49_E180;pipe_49_E181", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_942_generated", "shape": null, "area": 0.64, "streetlevel": 975.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 975.4000244140625, "distance_right": 2.2195392457113109e-07, "index_right": 949, "nodeid": "1390225.520736_5866236.724811", "id": "1390225.520736_5866236.724811", "name": "manhole_942_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390225.520736138802022, 5866236.724811173044145 ] } }, +{ "type": "Feature", "properties": { "_index": 941, "bedlevel": 1031.5, "branchid": "pipe_49_E181;pipe_49_E182", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_943_generated", "shape": null, "area": 0.64, "streetlevel": 1034.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1034.5, "distance_right": 4.3644965847580387e-07, "index_right": 950, "nodeid": "1390175.681368_5866235.232718", "id": "1390175.681368_5866235.232718", "name": "manhole_943_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390175.681368115358055, 5866235.232718421146274 ] } }, +{ "type": "Feature", "properties": { "_index": 942, "bedlevel": 1031.5, "branchid": "pipe_49_E182;pipe_49_E183", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_944_generated", "shape": null, "area": 0.64, "streetlevel": 1034.5, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1034.5, "distance_right": 3.4323501485718629e-07, "index_right": 951, "nodeid": "1390125.842000_5866233.740626", "id": "1390125.842000_5866233.740626", "name": "manhole_944_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390125.842000092146918, 5866233.740625669248402 ] } }, +{ "type": "Feature", "properties": { "_index": 943, "bedlevel": 1050.9000244140625, "branchid": "pipe_49_E183;pipe_49_E184", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_945_generated", "shape": null, "area": 0.64, "streetlevel": 1053.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1053.9000244140625, "distance_right": 1.0693214671935539e-07, "index_right": 952, "nodeid": "1390076.002632_5866232.248533", "id": "1390076.002632_5866232.248533", "name": "manhole_945_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390076.002632068702951, 5866232.248532918281853 ] } }, +{ "type": "Feature", "properties": { "_index": 944, "bedlevel": 953.9000244140625, "branchid": "pipe_49_E184;pipe_49_E185", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_946_generated", "shape": null, "area": 0.64, "streetlevel": 956.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 956.9000244140625, "distance_right": 1.7271765716066688e-07, "index_right": 953, "nodeid": "1390026.163264_5866230.756440", "id": "1390026.163264_5866230.756440", "name": "manhole_946_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1390026.163264045258984, 5866230.756440166383982 ] } }, +{ "type": "Feature", "properties": { "_index": 945, "bedlevel": 985.79998779296875, "branchid": "pipe_49_E185;pipe_49_E186", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_947_generated", "shape": null, "area": 0.64, "streetlevel": 988.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 988.79998779296875, "distance_right": 4.1502837781950249e-07, "index_right": 954, "nodeid": "1389976.323896_5866229.264347", "id": "1389976.323896_5866229.264347", "name": "manhole_947_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389976.323896022047848, 5866229.26434741448611 ] } }, +{ "type": "Feature", "properties": { "_index": 946, "bedlevel": 985.79998779296875, "branchid": "pipe_49_E186;pipe_49_E187", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_948_generated", "shape": null, "area": 0.64, "streetlevel": 988.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 988.79998779296875, "distance_right": 3.3621035174470345e-07, "index_right": 955, "nodeid": "1389926.484528_5866227.772255", "id": "1389926.484528_5866227.772255", "name": "manhole_948_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389926.48452799860388, 5866227.772254663519561 ] } }, +{ "type": "Feature", "properties": { "_index": 947, "bedlevel": 1048.0999755859375, "branchid": "pipe_49_E187;pipe_49_E188", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_949_generated", "shape": null, "area": 0.64, "streetlevel": 1051.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1051.0999755859375, "distance_right": 9.1916218476309546e-08, "index_right": 956, "nodeid": "1389876.645160_5866226.280162", "id": "1389876.645160_5866226.280162", "name": "manhole_949_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389876.645159975159913, 5866226.28016191162169 ] } }, +{ "type": "Feature", "properties": { "_index": 948, "bedlevel": 1048.0999755859375, "branchid": "pipe_49_E188;pipe_49_E189", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_950_generated", "shape": null, "area": 0.64, "streetlevel": 1051.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1051.0999755859375, "distance_right": 1.6721390440459392e-07, "index_right": 957, "nodeid": "1389826.805792_5866224.788069", "id": "1389826.805792_5866224.788069", "name": "manhole_950_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389826.805791951948777, 5866224.788069159723818 ] } }, +{ "type": "Feature", "properties": { "_index": 949, "bedlevel": 1063.9000244140625, "branchid": "pipe_49_E189;pipe_49_E190", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_951_generated", "shape": null, "area": 0.64, "streetlevel": 1066.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1066.9000244140625, "distance_right": 4.1505188836408448e-07, "index_right": 958, "nodeid": "1389776.966424_5866223.295976", "id": "1389776.966424_5866223.295976", "name": "manhole_951_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389776.96642392850481, 5866223.295976408757269 ] } }, +{ "type": "Feature", "properties": { "_index": 950, "bedlevel": 1028.2000732421875, "branchid": "pipe_49_E190;pipe_49_E191", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_952_generated", "shape": null, "area": 0.64, "streetlevel": 1031.2000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1031.2000732421875, "distance_right": 1.7605953720432244e-07, "index_right": 959, "nodeid": "1389727.141183_5866221.468200", "id": "1389727.141183_5866221.468200", "name": "manhole_952_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389727.141182830790058, 5866221.468200048431754 ] } }, +{ "type": "Feature", "properties": { "_index": 951, "bedlevel": 1028.2000732421875, "branchid": "pipe_49_E191;pipe_49_E192", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_953_generated", "shape": null, "area": 0.64, "streetlevel": 1031.2000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1031.2000732421875, "distance_right": 3.6128834460839566e-07, "index_right": 960, "nodeid": "1389677.352676_5866218.767548", "id": "1389677.352676_5866218.767548", "name": "manhole_953_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389677.352675863076001, 5866218.767548334784806 ] } }, +{ "type": "Feature", "properties": { "_index": 952, "bedlevel": 983.60003662109375, "branchid": "pipe_49_E192;pipe_49_E193", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_954_generated", "shape": null, "area": 0.64, "streetlevel": 986.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 986.60003662109375, "distance_right": 3.9313838553029594e-07, "index_right": 961, "nodeid": "1389627.564169_5866216.066897", "id": "1389627.564169_5866216.066897", "name": "manhole_954_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389627.564168895594776, 5866216.066896621137857 ] } }, +{ "type": "Feature", "properties": { "_index": 953, "bedlevel": 983.60003662109375, "branchid": "pipe_49_E193;pipe_49_E194", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_955_generated", "shape": null, "area": 0.64, "streetlevel": 986.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 986.60003662109375, "distance_right": 1.1709228767436902e-07, "index_right": 962, "nodeid": "1389577.775662_5866213.366245", "id": "1389577.775662_5866213.366245", "name": "manhole_955_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389577.775661927880719, 5866213.366244907490909 ] } }, +{ "type": "Feature", "properties": { "_index": 954, "bedlevel": 961.70001220703125, "branchid": "pipe_49_E194;pipe_49_E195", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_956_generated", "shape": null, "area": 0.64, "streetlevel": 964.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 964.70001220703125, "distance_right": 1.9867658609749133e-07, "index_right": 963, "nodeid": "1389527.987155_5866210.665593", "id": "1389527.987155_5866210.665593", "name": "manhole_956_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389527.987154960166663, 5866210.665593194775283 ] } }, +{ "type": "Feature", "properties": { "_index": 955, "bedlevel": 961.70001220703125, "branchid": "pipe_49_E195;pipe_49_E196", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_957_generated", "shape": null, "area": 0.64, "streetlevel": 964.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 964.70001220703125, "distance_right": 4.8155141235013908e-07, "index_right": 964, "nodeid": "1389478.198648_5866207.964941", "id": "1389478.198648_5866207.964941", "name": "manhole_957_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389478.198647992452607, 5866207.964941481128335 ] } }, +{ "type": "Feature", "properties": { "_index": 956, "bedlevel": 993.29998779296875, "branchid": "pipe_49_E196;pipe_49_E197", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_958_generated", "shape": null, "area": 0.64, "streetlevel": 996.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 996.29998779296875, "distance_right": 2.3413503241671798e-07, "index_right": 965, "nodeid": "1389428.410141_5866205.264290", "id": "1389428.410141_5866205.264290", "name": "manhole_958_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389428.41014102473855, 5866205.264289767481387 ] } }, +{ "type": "Feature", "properties": { "_index": 957, "bedlevel": 993.29998779296875, "branchid": "pipe_49_E197;pipe_49_E198", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_959_generated", "shape": null, "area": 0.64, "streetlevel": 996.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 996.29998779296875, "distance_right": 7.856059226332952e-08, "index_right": 966, "nodeid": "1389378.621634_5866202.563638", "id": "1389378.621634_5866202.563638", "name": "manhole_959_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389378.621634057024494, 5866202.563638053834438 ] } }, +{ "type": "Feature", "properties": { "_index": 958, "bedlevel": 1027.4000244140625, "branchid": "pipe_49_E198;pipe_49_E199", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_960_generated", "shape": null, "area": 0.64, "streetlevel": 1030.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1030.4000244140625, "distance_right": 3.514937742276614e-07, "index_right": 967, "nodeid": "1389328.833127_5866199.862986", "id": "1389328.833127_5866199.862986", "name": "manhole_960_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389328.833127089310437, 5866199.86298634018749 ] } }, +{ "type": "Feature", "properties": { "_index": 959, "bedlevel": 1027.4000244140625, "branchid": "pipe_49_E199;pipe_49_E200", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_961_generated", "shape": null, "area": 0.64, "streetlevel": 1030.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1030.4000244140625, "distance_right": 3.9281124173343443e-07, "index_right": 968, "nodeid": "1389279.044620_5866197.162335", "id": "1389279.044620_5866197.162335", "name": "manhole_961_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389279.044620121829212, 5866197.162334626540542 ] } }, +{ "type": "Feature", "properties": { "_index": 960, "bedlevel": 1050.800048828125, "branchid": "pipe_49_E200;pipe_49_E201", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_962_generated", "shape": null, "area": 0.64, "streetlevel": 1053.800048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1053.800048828125, "distance_right": 1.7726043879219753e-07, "index_right": 969, "nodeid": "1389229.256113_5866194.461683", "id": "1389229.256113_5866194.461683", "name": "manhole_962_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389229.256113154115155, 5866194.461682912893593 ] } }, +{ "type": "Feature", "properties": { "_index": 961, "bedlevel": 1050.800048828125, "branchid": "pipe_49_E201;pipe_49_E202", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_963_generated", "shape": null, "area": 0.64, "streetlevel": 1053.800048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1053.800048828125, "distance_right": 2.7295229996532459e-07, "index_right": 970, "nodeid": "1389179.467606_5866191.761031", "id": "1389179.467606_5866191.761031", "name": "manhole_963_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389179.467606186401099, 5866191.761031199246645 ] } }, +{ "type": "Feature", "properties": { "_index": 962, "bedlevel": 1064.5999755859375, "branchid": "pipe_49_E202;pipe_49_E203", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_964_generated", "shape": null, "area": 0.64, "streetlevel": 1067.5999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1067.5999755859375, "distance_right": 5.3219895594374747e-07, "index_right": 971, "nodeid": "1389129.679099_5866189.060379", "id": "1389129.679099_5866189.060379", "name": "manhole_964_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389129.679099218687043, 5866189.060379485599697 ] } }, +{ "type": "Feature", "properties": { "_index": 963, "bedlevel": 1067.7000732421875, "branchid": "pipe_49_E203;pipe_49_E204", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_965_generated", "shape": null, "area": 0.64, "streetlevel": 1070.7000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1070.7000732421875, "distance_right": 3.3920508279400263e-07, "index_right": 972, "nodeid": "1389079.890592_5866186.359728", "id": "1389079.890592_5866186.359728", "name": "manhole_965_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389079.890592250972986, 5866186.359727771952748 ] } }, +{ "type": "Feature", "properties": { "_index": 964, "bedlevel": 1067.7000732421875, "branchid": "pipe_49_E204;pipe_49_E205", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_966_generated", "shape": null, "area": 0.64, "streetlevel": 1070.7000732421875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1070.7000732421875, "distance_right": 2.8936577943892251e-07, "index_right": 973, "nodeid": "1389030.102085_5866183.659076", "id": "1389030.102085_5866183.659076", "name": "manhole_966_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1389030.10208528325893, 5866183.6590760583058 ] } }, +{ "type": "Feature", "properties": { "_index": 965, "bedlevel": 1072.0, "branchid": "pipe_49_E205;pipe_49_E206", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_967_generated", "shape": null, "area": 0.64, "streetlevel": 1075.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1075.0, "distance_right": 4.6804125381191257e-07, "index_right": 974, "nodeid": "1388980.313578_5866180.958424", "id": "1388980.313578_5866180.958424", "name": "manhole_967_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388980.313578315777704, 5866180.958424345590174 ] } }, +{ "type": "Feature", "properties": { "_index": 966, "bedlevel": 1072.0, "branchid": "pipe_49_E206;pipe_49_E207", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_968_generated", "shape": null, "area": 0.64, "streetlevel": 1075.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1075.0, "distance_right": 5.0644946756573003e-07, "index_right": 975, "nodeid": "1388930.525071_5866178.257773", "id": "1388930.525071_5866178.257773", "name": "manhole_968_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388930.525071348063648, 5866178.257772631943226 ] } }, +{ "type": "Feature", "properties": { "_index": 967, "bedlevel": 1071.0999755859375, "branchid": "pipe_49_E207;pipe_49_E208", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_969_generated", "shape": null, "area": 0.64, "streetlevel": 1074.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1074.0999755859375, "distance_right": 3.891727817833842e-07, "index_right": 976, "nodeid": "1388880.736564_5866175.557121", "id": "1388880.736564_5866175.557121", "name": "manhole_969_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388880.736564380349591, 5866175.557120918296278 ] } }, +{ "type": "Feature", "properties": { "_index": 968, "bedlevel": 1071.0999755859375, "branchid": "pipe_49_E208;pipe_49_E209", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_970_generated", "shape": null, "area": 0.64, "streetlevel": 1074.0999755859375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1074.0999755859375, "distance_right": 4.606508242010698e-07, "index_right": 977, "nodeid": "1388830.948057_5866172.856469", "id": "1388830.948057_5866172.856469", "name": "manhole_970_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388830.948057412635535, 5866172.856469204649329 ] } }, +{ "type": "Feature", "properties": { "_index": 969, "bedlevel": 1050.800048828125, "branchid": "pipe_49_E209;pipe_49_E210", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_971_generated", "shape": null, "area": 0.64, "streetlevel": 1053.800048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1053.800048828125, "distance_right": 6.6246701218026935e-07, "index_right": 978, "nodeid": "1388781.159550_5866170.155817", "id": "1388781.159550_5866170.155817", "name": "manhole_971_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388781.159550444921479, 5866170.155817491002381 ] } }, +{ "type": "Feature", "properties": { "_index": 970, "bedlevel": 1050.800048828125, "branchid": "pipe_49_E210;pipe_49_E211", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_972_generated", "shape": null, "area": 0.64, "streetlevel": 1053.800048828125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1053.800048828125, "distance_right": 5.2665221097907886e-07, "index_right": 979, "nodeid": "1388731.371043_5866167.455166", "id": "1388731.371043_5866167.455166", "name": "manhole_972_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388731.371043477207422, 5866167.455165777355433 ] } }, +{ "type": "Feature", "properties": { "_index": 971, "bedlevel": 1014.0, "branchid": "pipe_49_E211;pipe_49_E212", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_973_generated", "shape": null, "area": 0.64, "streetlevel": 1017.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1017.0, "distance_right": 4.9464501735930622e-07, "index_right": 980, "nodeid": "1388681.582537_5866164.754514", "id": "1388681.582537_5866164.754514", "name": "manhole_973_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388681.582536509493366, 5866164.754514063708484 ] } }, +{ "type": "Feature", "properties": { "_index": 972, "bedlevel": 1014.0, "branchid": "pipe_49_E212;pipe_49_E213", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_974_generated", "shape": null, "area": 0.64, "streetlevel": 1017.0, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 1017.0, "distance_right": 5.7651354540620896e-07, "index_right": 981, "nodeid": "1388631.794030_5866162.053862", "id": "1388631.794030_5866162.053862", "name": "manhole_974_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388631.79402954201214, 5866162.053862350061536 ] } }, +{ "type": "Feature", "properties": { "_index": 973, "bedlevel": 970.20001220703125, "branchid": "pipe_49_E213;pipe_49_E214", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_975_generated", "shape": null, "area": 0.64, "streetlevel": 973.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 973.20001220703125, "distance_right": 5.59529580956339e-07, "index_right": 982, "nodeid": "1388582.005523_5866159.353211", "id": "1388582.005523_5866159.353211", "name": "manhole_975_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388582.005522574298084, 5866159.353210636414587 ] } }, +{ "type": "Feature", "properties": { "_index": 974, "bedlevel": 970.20001220703125, "branchid": "pipe_49_E214;pipe_49_E215", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_976_generated", "shape": null, "area": 0.64, "streetlevel": 973.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 973.20001220703125, "distance_right": 4.0100467111343551e-07, "index_right": 983, "nodeid": "1388532.217016_5866156.652559", "id": "1388532.217016_5866156.652559", "name": "manhole_976_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388532.217015606584027, 5866156.652558922767639 ] } }, +{ "type": "Feature", "properties": { "_index": 975, "bedlevel": 932.20001220703125, "branchid": "pipe_49_E215;pipe_49_E216", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_977_generated", "shape": null, "area": 0.64, "streetlevel": 935.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 935.20001220703125, "distance_right": 4.1751416682829823e-07, "index_right": 984, "nodeid": "1388482.428509_5866153.951907", "id": "1388482.428509_5866153.951907", "name": "manhole_977_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388482.428508638869971, 5866153.951907209120691 ] } }, +{ "type": "Feature", "properties": { "_index": 976, "bedlevel": 932.20001220703125, "branchid": "pipe_49_E216;pipe_49_E217", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_978_generated", "shape": null, "area": 0.64, "streetlevel": 935.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 935.20001220703125, "distance_right": 5.9538979466596884e-07, "index_right": 985, "nodeid": "1388432.640002_5866151.251255", "id": "1388432.640002_5866151.251255", "name": "manhole_978_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388432.640001671155915, 5866151.251255496405065 ] } }, +{ "type": "Feature", "properties": { "_index": 977, "bedlevel": 892.79998779296875, "branchid": "pipe_49_E217;pipe_49_E218", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_979_generated", "shape": null, "area": 0.64, "streetlevel": 895.79998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 895.79998779296875, "distance_right": 3.6752595508223165e-07, "index_right": 986, "nodeid": "1388382.851495_5866148.550604", "id": "1388382.851495_5866148.550604", "name": "manhole_979_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388382.851494703441858, 5866148.550603782758117 ] } }, +{ "type": "Feature", "properties": { "_index": 978, "bedlevel": 849.60003662109375, "branchid": "pipe_49_E218;pipe_49_E219", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_980_generated", "shape": null, "area": 0.64, "streetlevel": 852.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 852.60003662109375, "distance_right": 2.7287632239397937e-07, "index_right": 987, "nodeid": "1388333.062988_5866145.849952", "id": "1388333.062988_5866145.849952", "name": "manhole_980_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388333.062987735960633, 5866145.849952069111168 ] } }, +{ "type": "Feature", "properties": { "_index": 979, "bedlevel": 849.60003662109375, "branchid": "pipe_49_E219;pipe_49_E220", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_981_generated", "shape": null, "area": 0.64, "streetlevel": 852.60003662109375, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 852.60003662109375, "distance_right": 4.2454476447716075e-07, "index_right": 988, "nodeid": "1388283.274481_5866143.149300", "id": "1388283.274481_5866143.149300", "name": "manhole_981_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388283.274480768246576, 5866143.14930035546422 ] } }, +{ "type": "Feature", "properties": { "_index": 980, "bedlevel": 815.4000244140625, "branchid": "pipe_49_E220;pipe_49_E221", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_982_generated", "shape": null, "area": 0.64, "streetlevel": 818.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 818.4000244140625, "distance_right": 4.1034041195368685e-07, "index_right": 989, "nodeid": "1388233.485974_5866140.448649", "id": "1388233.485974_5866140.448649", "name": "manhole_982_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388233.48597380053252, 5866140.448648641817272 ] } }, +{ "type": "Feature", "properties": { "_index": 981, "bedlevel": 815.4000244140625, "branchid": "pipe_49_E221;pipe_52_E0", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_983_generated", "shape": null, "area": 0.64, "streetlevel": 818.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 818.4000244140625, "distance_right": 1.8190436988416221e-07, "index_right": 990, "nodeid": "1388183.697467_5866137.747997", "id": "1388183.697467_5866137.747997", "name": "manhole_983_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388183.697466832818463, 5866137.747996928170323 ] } }, +{ "type": "Feature", "properties": { "_index": 982, "bedlevel": 791.70001220703125, "branchid": "pipe_50_E0;pipe_50_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_984_generated", "shape": null, "area": 0.64, "streetlevel": 794.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 794.70001220703125, "distance_right": 5.9866458985618213e-08, "index_right": 991, "nodeid": "1387925.204459_5865784.545683", "id": "1387925.204459_5865784.545683", "name": "manhole_984_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387925.20445894007571, 5865784.545682998374104 ] } }, +{ "type": "Feature", "properties": { "_index": 983, "bedlevel": 801.4000244140625, "branchid": "pipe_50_E1;pipe_50_E2", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_985_generated", "shape": null, "area": 0.64, "streetlevel": 804.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 804.4000244140625, "distance_right": 3.4867001082566627e-07, "index_right": 992, "nodeid": "1387937.211691_5865832.252126", "id": "1387937.211691_5865832.252126", "name": "manhole_985_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387937.21169110503979, 5865832.252126332372427 ] } }, +{ "type": "Feature", "properties": { "_index": 984, "bedlevel": 801.4000244140625, "branchid": "pipe_50_E2;pipe_50_E3", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_986_generated", "shape": null, "area": 0.64, "streetlevel": 804.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 804.4000244140625, "distance_right": 3.2490020949153345e-07, "index_right": 993, "nodeid": "1387954.827088_5865878.043408", "id": "1387954.827088_5865878.043408", "name": "manhole_986_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387954.8270876808092, 5865878.043407939374447 ] } }, +{ "type": "Feature", "properties": { "_index": 985, "bedlevel": 801.4000244140625, "branchid": "pipe_50_E3;pipe_50_E4", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_987_generated", "shape": null, "area": 0.64, "streetlevel": 804.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 804.4000244140625, "distance_right": 3.9004074068770563e-07, "index_right": 994, "nodeid": "1387967.620662_5865925.436967", "id": "1387967.620662_5865925.436967", "name": "manhole_987_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387967.620662312954664, 5865925.436966767534614 ] } }, +{ "type": "Feature", "properties": { "_index": 986, "bedlevel": 775.20001220703125, "branchid": "pipe_50_E4;pipe_50_E5", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_988_generated", "shape": null, "area": 0.64, "streetlevel": 778.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 778.20001220703125, "distance_right": 3.6606967785989592e-07, "index_right": 995, "nodeid": "1387969.561903_5865974.386314", "id": "1387969.561903_5865974.386314", "name": "manhole_988_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387969.561903131194413, 5865974.386314341798425 ] } }, +{ "type": "Feature", "properties": { "_index": 987, "bedlevel": 775.20001220703125, "branchid": "pipe_50_E5;pipe_50_E6", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_989_generated", "shape": null, "area": 0.64, "streetlevel": 778.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 778.20001220703125, "distance_right": 2.676742433793445e-07, "index_right": 996, "nodeid": "1387968.982558_5866023.571072", "id": "1387968.982558_5866023.571072", "name": "manhole_989_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387968.98255812516436, 5866023.571071763522923 ] } }, +{ "type": "Feature", "properties": { "_index": 988, "bedlevel": 775.20001220703125, "branchid": "pipe_50_E6;pipe_50_E7", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_990_generated", "shape": null, "area": 0.64, "streetlevel": 778.20001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 778.20001220703125, "distance_right": 4.3598829608959754e-07, "index_right": 997, "nodeid": "1387969.225197_5866072.657253", "id": "1387969.225197_5866072.657253", "name": "manhole_990_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387969.225197304505855, 5866072.657253311946988 ] } }, +{ "type": "Feature", "properties": { "_index": 989, "bedlevel": 783.29998779296875, "branchid": "pipe_50_E7;pipe_50_E8", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_991_generated", "shape": null, "area": 0.64, "streetlevel": 786.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 786.29998779296875, "distance_right": 4.7751884879743965e-07, "index_right": 998, "nodeid": "1387988.247400_5866112.298415", "id": "1387988.247400_5866112.298415", "name": "manhole_991_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387988.247399942483753, 5866112.298415473662317 ] } }, +{ "type": "Feature", "properties": { "_index": 990, "bedlevel": 783.29998779296875, "branchid": "pipe_50_E8;pipe_51_E0;pipe_52_E2", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_992_generated", "shape": null, "area": 0.64, "streetlevel": 786.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 786.29998779296875, "distance_right": 3.4258060355880119e-07, "index_right": 999, "nodeid": "1388034.037428_5866130.255608", "id": "1388034.037428_5866130.255608", "name": "manhole_992_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388034.037428337847814, 5866130.255607943050563 ] } }, +{ "type": "Feature", "properties": { "_index": 991, "bedlevel": 783.29998779296875, "branchid": "pipe_51_E0;pipe_51_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_993_generated", "shape": null, "area": 0.64, "streetlevel": 786.29998779296875, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 786.29998779296875, "distance_right": 6.4243645308526241e-07, "index_right": 1000, "nodeid": "1387988.210685_5866144.678138", "id": "1387988.210685_5866144.678138", "name": "manhole_993_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387988.210684564430267, 5866144.678138472139835 ] } }, +{ "type": "Feature", "properties": { "_index": 992, "bedlevel": 800.9000244140625, "branchid": "pipe_51_E1;pipe_51_E2", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_994_generated", "shape": null, "area": 0.64, "streetlevel": 803.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 803.9000244140625, "distance_right": 1.3903011605945694e-07, "index_right": 1001, "nodeid": "1387944.406121_5866164.065103", "id": "1387944.406121_5866164.065103", "name": "manhole_994_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387944.406121137319133, 5866164.065103021450341 ] } }, +{ "type": "Feature", "properties": { "_index": 993, "bedlevel": 800.9000244140625, "branchid": "pipe_51_E2;pipe_51_E3", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_995_generated", "shape": null, "area": 0.64, "streetlevel": 803.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 803.9000244140625, "distance_right": 1.9915718645449805e-07, "index_right": 1002, "nodeid": "1387898.376188_5866173.560076", "id": "1387898.376188_5866173.560076", "name": "manhole_995_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387898.376188111724332, 5866173.560075835324824 ] } }, +{ "type": "Feature", "properties": { "_index": 994, "bedlevel": 824.70001220703125, "branchid": "pipe_51_E3;pipe_51_E4", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_996_generated", "shape": null, "area": 0.64, "streetlevel": 827.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 827.70001220703125, "distance_right": 5.0607040580195112e-07, "index_right": 1003, "nodeid": "1387861.922561_5866145.113870", "id": "1387861.922561_5866145.113870", "name": "manhole_996_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387861.922560503939167, 5866145.113870099186897 ] } }, +{ "type": "Feature", "properties": { "_index": 995, "bedlevel": 824.70001220703125, "branchid": "pipe_51_E4;pipe_51_E5", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_997_generated", "shape": null, "area": 0.64, "streetlevel": 827.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 827.70001220703125, "distance_right": 4.3784946248219545e-07, "index_right": 1004, "nodeid": "1387862.597009_5866099.287654", "id": "1387862.597009_5866099.287654", "name": "manhole_997_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387862.597008766839281, 5866099.287653629668057 ] } }, +{ "type": "Feature", "properties": { "_index": 996, "bedlevel": 813.70001220703125, "branchid": "pipe_51_E5;pipe_51_E6", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_998_generated", "shape": null, "area": 0.64, "streetlevel": 816.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 816.70001220703125, "distance_right": 4.2940434915154824e-07, "index_right": 1005, "nodeid": "1387894.296242_5866064.312252", "id": "1387894.296242_5866064.312252", "name": "manhole_998_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387894.296242429409176, 5866064.31225199252367 ] } }, +{ "type": "Feature", "properties": { "_index": 997, "bedlevel": 813.70001220703125, "branchid": "pipe_51_E6;pipe_51_E7", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_999_generated", "shape": null, "area": 0.64, "streetlevel": 816.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 816.70001220703125, "distance_right": 5.291142332498509e-07, "index_right": 1006, "nodeid": "1387918.333023_5866023.860150", "id": "1387918.333023_5866023.860150", "name": "manhole_999_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387918.333023339277133, 5866023.860149594023824 ] } }, +{ "type": "Feature", "properties": { "_index": 998, "bedlevel": 813.70001220703125, "branchid": "pipe_51_E7;pipe_51_E8", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_1000_generated", "shape": null, "area": 0.64, "streetlevel": 816.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 816.70001220703125, "distance_right": 4.1160348816863167e-07, "index_right": 1007, "nodeid": "1387925.576027_5865976.462518", "id": "1387925.576027_5865976.462518", "name": "manhole_1000_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387925.576027213362977, 5865976.462517648003995 ] } }, +{ "type": "Feature", "properties": { "_index": 999, "bedlevel": 801.4000244140625, "branchid": "pipe_51_E8;pipe_51_E9", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_1001_generated", "shape": null, "area": 0.64, "streetlevel": 804.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 804.4000244140625, "distance_right": 2.6634696055791994e-07, "index_right": 1008, "nodeid": "1387926.166852_5865928.505293", "id": "1387926.166852_5865928.505293", "name": "manhole_1001_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387926.166851800866425, 5865928.505292822606862 ] } }, +{ "type": "Feature", "properties": { "_index": 1000, "bedlevel": 801.4000244140625, "branchid": "pipe_51_E9;pipe_51_E10", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_1002_generated", "shape": null, "area": 0.64, "streetlevel": 804.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 804.4000244140625, "distance_right": 2.9363738265143579e-07, "index_right": 1009, "nodeid": "1387922.175475_5865880.628694", "id": "1387922.175475_5865880.628694", "name": "manhole_1002_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387922.175474973395467, 5865880.628693707287312 ] } }, +{ "type": "Feature", "properties": { "_index": 1001, "bedlevel": 801.4000244140625, "branchid": "pipe_51_E10;pipe_51_E11", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_1003_generated", "shape": null, "area": 0.64, "streetlevel": 804.4000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 804.4000244140625, "distance_right": 4.3245670675986009e-07, "index_right": 1010, "nodeid": "1387918.184098_5865832.752095", "id": "1387918.184098_5865832.752095", "name": "manhole_1003_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387918.184098146157339, 5865832.752094592899084 ] } }, +{ "type": "Feature", "properties": { "_index": 1002, "bedlevel": 791.70001220703125, "branchid": "pipe_51_E11;pipe_51_E12", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_1004_generated", "shape": null, "area": 0.64, "streetlevel": 794.70001220703125, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 794.70001220703125, "distance_right": 4.0146728020930125e-07, "index_right": 1011, "nodeid": "1387914.316890_5865784.868878", "id": "1387914.316890_5865784.868878", "name": "manhole_1004_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1387914.316889721900225, 5865784.868878290057182 ] } }, +{ "type": "Feature", "properties": { "_index": 1004, "bedlevel": 800.9000244140625, "branchid": "pipe_52_E0;pipe_52_E1", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_1005_generated", "shape": null, "area": 0.64, "streetlevel": 803.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 803.9000244140625, "distance_right": 3.4123100246825885e-07, "index_right": 1012, "nodeid": "1388133.810787_5866135.250534", "id": "1388133.810787_5866135.250534", "name": "manhole_1005_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388133.810787334572524, 5866135.250533932819963 ] } }, +{ "type": "Feature", "properties": { "_index": 1005, "bedlevel": 800.9000244140625, "branchid": "pipe_52_E1;pipe_52_E2", "branchtype": "pipe", "width": null, "diameter": 0.5, "manholeid": "manhole_1006_generated", "shape": null, "area": 0.64, "streetlevel": 803.9000244140625, "streetstoragearea": 500.0, "storagetype": "reservoir", "_streetlevel_dem": 803.9000244140625, "distance_right": 1.7505891844349512e-07, "index_right": 1013, "nodeid": "1388083.924108_5866132.753071", "id": "1388083.924108_5866132.753071", "name": "manhole_1006_generated", "usetable": false }, "geometry": { "type": "Point", "coordinates": [ 1388083.924107836093754, 5866132.753070938400924 ] } } ] } diff --git a/examples/dflowfm_piave/geoms/pipes.geojson b/examples/dflowfm_piave/geoms/pipes.geojson index 69d7ea5d..8e6d673c 100644 --- a/examples/dflowfm_piave/geoms/pipes.geojson +++ b/examples/dflowfm_piave/geoms/pipes.geojson @@ -2,2010 +2,1006 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::3857" } }, "features": [ -<<<<<<< HEAD -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_1_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389238.298387300921604, 5860147.714495398104191 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 933.5, "invlev_up": 913.4000244140625, "invlev_dn": 931.0, "manhole_up": "manhole_1_generated", "manhole_dn": "manhole_2_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389238.298387300921604, 5860147.714495398104191 ], [ 1389210.947846550960094, 5860184.343885350972414 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.5, "elevtn_dn": 933.5, "invlev_up": 931.0, "invlev_dn": 931.0, "manhole_up": "manhole_2_generated", "manhole_dn": "manhole_3_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389210.947846550960094, 5860184.343885350972414 ], [ 1389186.961922727525234, 5860223.315261371433735 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.5, "elevtn_dn": 935.5, "invlev_up": 931.0, "invlev_dn": 933.0, "manhole_up": "manhole_3_generated", "manhole_dn": "manhole_4_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389186.961922727525234, 5860223.315261371433735 ], [ 1389162.755598766496405, 5860262.142883376218379 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 935.5, "invlev_up": 933.0, "invlev_dn": 933.0, "manhole_up": "manhole_4_generated", "manhole_dn": "manhole_5_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389162.755598766496405, 5860262.142883376218379 ], [ 1389136.759307563304901, 5860299.80301527120173 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 936.5, "invlev_up": 933.0, "invlev_dn": 934.0, "manhole_up": "manhole_5_generated", "manhole_dn": "manhole_6_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389136.759307563304901, 5860299.80301527120173 ], [ 1389109.7301227634307, 5860336.652257356792688 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 936.5, "elevtn_dn": 941.10003662109375, "invlev_up": 934.0, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_6_generated", "manhole_dn": "manhole_7_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389109.7301227634307, 5860336.652257356792688 ], [ 1389073.18478828552179, 5860363.522737024351954 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_7_generated", "manhole_dn": "manhole_8_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389073.18478828552179, 5860363.522737024351954 ], [ 1389032.546542100608349, 5860384.329287325032055 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_8_generated", "manhole_dn": "manhole_9_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389032.546542100608349, 5860384.329287325032055 ], [ 1388989.578410296700895, 5860400.071978960186243 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_6_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_6", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 951.29998779296875, "invlev_up": 938.60003662109375, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_9_generated", "manhole_dn": "manhole_10_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388989.578410296700895, 5860400.071978960186243 ], [ 1388946.301100668497384, 5860414.883977899327874 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_11_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389221.905703959986567, 5860123.3256367566064 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_11_generated", "manhole_dn": "manhole_12_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389221.905703959986567, 5860123.3256367566064 ], [ 1389177.295895804418251, 5860134.962970778346062 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 919.60003662109375, "invlev_up": 913.4000244140625, "invlev_dn": 917.10003662109375, "manhole_up": "manhole_12_generated", "manhole_dn": "manhole_13_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389177.295895804418251, 5860134.962970778346062 ], [ 1389132.686087648617104, 5860146.600304800085723 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 919.60003662109375, "elevtn_dn": 919.60003662109375, "invlev_up": 917.10003662109375, "invlev_dn": 917.10003662109375, "manhole_up": "manhole_13_generated", "manhole_dn": "manhole_14_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389132.686087648617104, 5860146.600304800085723 ], [ 1389088.076279493048787, 5860158.237638821825385 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 919.60003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 917.10003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_14_generated", "manhole_dn": "manhole_15_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389088.076279493048787, 5860158.237638821825385 ], [ 1389044.226173994829878, 5860172.143308508209884 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 935.60003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_15_generated", "manhole_dn": "manhole_16_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389044.226173994829878, 5860172.143308508209884 ], [ 1389012.527182487538084, 5860198.239755615592003 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 935.60003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_16_generated", "manhole_dn": "manhole_17_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389012.527182487538084, 5860198.239755615592003 ], [ 1388995.773122631013393, 5860240.481283166445792 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 945.0, "invlev_up": 935.60003662109375, "invlev_dn": 942.5, "manhole_up": "manhole_17_generated", "manhole_dn": "manhole_18_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388995.773122631013393, 5860240.481283166445792 ], [ 1388973.630034049740061, 5860280.918223639950156 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.0, "elevtn_dn": 951.29998779296875, "invlev_up": 942.5, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_18_generated", "manhole_dn": "manhole_19_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388973.630034049740061, 5860280.918223639950156 ], [ 1388961.171157888136804, 5860324.081192856654525 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_19_generated", "manhole_dn": "manhole_20_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388961.171157888136804, 5860324.081192856654525 ], [ 1388955.410555170848966, 5860369.690168970264494 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_7_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_7", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_20_generated", "manhole_dn": "manhole_10_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388955.410555170848966, 5860369.690168970264494 ], [ 1388946.301100668497384, 5860414.883977899327874 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 914.5, "invlev_up": 913.4000244140625, "invlev_dn": 912.0, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_21_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389306.50000010849908, 5860083.476415127515793 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 914.5, "elevtn_dn": 914.5, "invlev_up": 912.0, "invlev_dn": 912.0, "manhole_up": "manhole_21_generated", "manhole_dn": "manhole_22_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389306.50000010849908, 5860083.476415127515793 ], [ 1389355.420758404070511, 5860074.630405306816101 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 914.5, "elevtn_dn": 929.9000244140625, "invlev_up": 912.0, "invlev_dn": 927.4000244140625, "manhole_up": "manhole_22_generated", "manhole_dn": "manhole_23_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389355.420758404070511, 5860074.630405306816101 ], [ 1389389.090761042200029, 5860042.4449307853356 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 929.9000244140625, "elevtn_dn": 955.0, "invlev_up": 927.4000244140625, "invlev_dn": 952.5, "manhole_up": "manhole_23_generated", "manhole_dn": "manhole_24_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389389.090761042200029, 5860042.4449307853356 ], [ 1389404.036260401364416, 5859994.775433851405978 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_24_generated", "manhole_dn": "manhole_25_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389404.036260401364416, 5859994.775433851405978 ], [ 1389418.744130451697856, 5859947.032028519548476 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_25_generated", "manhole_dn": "manhole_26_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389418.744130451697856, 5859947.032028519548476 ], [ 1389423.265342897269875, 5859897.853969652205706 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 975.29998779296875, "invlev_up": 952.5, "invlev_dn": 972.79998779296875, "manhole_up": "manhole_26_generated", "manhole_dn": "manhole_27_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389423.265342897269875, 5859897.853969652205706 ], [ 1389395.831073811277747, 5859856.743154510855675 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 975.29998779296875, "elevtn_dn": 963.0, "invlev_up": 972.79998779296875, "invlev_dn": 960.5, "manhole_up": "manhole_27_generated", "manhole_dn": "manhole_28_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389395.831073811277747, 5859856.743154510855675 ], [ 1389350.827042841585353, 5859839.640478814020753 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 963.0, "elevtn_dn": 963.0, "invlev_up": 960.5, "invlev_dn": 960.5, "manhole_up": "manhole_28_generated", "manhole_dn": "manhole_29_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389350.827042841585353, 5859839.640478814020753 ], [ 1389303.795788601972163, 5859855.887689013034105 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 963.0, "elevtn_dn": 945.4000244140625, "invlev_up": 960.5, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_29_generated", "manhole_dn": "manhole_30_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389303.795788601972163, 5859855.887689013034105 ], [ 1389256.284586790716276, 5859863.631580747663975 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 945.4000244140625, "invlev_up": 942.9000244140625, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_30_generated", "manhole_dn": "manhole_31_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389256.284586790716276, 5859863.631580747663975 ], [ 1389227.308454349869862, 5859823.781623384915292 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 945.4000244140625, "invlev_up": 942.9000244140625, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_31_generated", "manhole_dn": "manhole_32_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389227.308454349869862, 5859823.781623384915292 ], [ 1389202.745489193825051, 5859780.279727600514889 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 959.10003662109375, "invlev_up": 942.9000244140625, "invlev_dn": 956.60003662109375, "manhole_up": "manhole_32_generated", "manhole_dn": "manhole_33_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389202.745489193825051, 5859780.279727600514889 ], [ 1389178.18252403778024, 5859736.777831817045808 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 959.10003662109375, "elevtn_dn": 944.79998779296875, "invlev_up": 956.60003662109375, "invlev_dn": 942.29998779296875, "manhole_up": "manhole_33_generated", "manhole_dn": "manhole_34_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389178.18252403778024, 5859736.777831817045808 ], [ 1389155.231297271326184, 5859692.450142606161535 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 944.79998779296875, "elevtn_dn": 944.79998779296875, "invlev_up": 942.29998779296875, "invlev_dn": 942.29998779296875, "manhole_up": "manhole_34_generated", "manhole_dn": "manhole_35_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389155.231297271326184, 5859692.450142606161535 ], [ 1389141.413412723457441, 5859644.883844587020576 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 944.79998779296875, "elevtn_dn": 952.4000244140625, "invlev_up": 942.29998779296875, "invlev_dn": 949.9000244140625, "manhole_up": "manhole_35_generated", "manhole_dn": "manhole_36_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389141.413412723457441, 5859644.883844587020576 ], [ 1389151.802280035568401, 5859598.61804121825844 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.4000244140625, "elevtn_dn": 960.70001220703125, "invlev_up": 949.9000244140625, "invlev_dn": 958.20001220703125, "manhole_up": "manhole_36_generated", "manhole_dn": "manhole_37_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389151.802280035568401, 5859598.61804121825844 ], [ 1389191.073854762827978, 5859569.046822287142277 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 960.70001220703125, "elevtn_dn": 960.70001220703125, "invlev_up": 958.20001220703125, "invlev_dn": 958.20001220703125, "manhole_up": "manhole_37_generated", "manhole_dn": "manhole_38_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389191.073854762827978, 5859569.046822287142277 ], [ 1389239.915165816899389, 5859563.955490378662944 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 960.70001220703125, "elevtn_dn": 969.60003662109375, "invlev_up": 958.20001220703125, "invlev_dn": 967.10003662109375, "manhole_up": "manhole_38_generated", "manhole_dn": "manhole_39_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389239.915165816899389, 5859563.955490378662944 ], [ 1389289.757686472963542, 5859566.285022127442062 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 969.60003662109375, "elevtn_dn": 969.60003662109375, "invlev_up": 967.10003662109375, "invlev_dn": 967.10003662109375, "manhole_up": "manhole_39_generated", "manhole_dn": "manhole_40_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389289.757686472963542, 5859566.285022127442062 ], [ 1389339.615828452631831, 5859566.079234052449465 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 969.60003662109375, "elevtn_dn": 976.29998779296875, "invlev_up": 967.10003662109375, "invlev_dn": 973.79998779296875, "manhole_up": "manhole_40_generated", "manhole_dn": "manhole_41_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389339.615828452631831, 5859566.079234052449465 ], [ 1389387.354307833593339, 5859551.676988741382957 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 976.29998779296875, "elevtn_dn": 976.29998779296875, "invlev_up": 973.79998779296875, "invlev_dn": 973.79998779296875, "manhole_up": "manhole_41_generated", "manhole_dn": "manhole_42_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389387.354307833593339, 5859551.676988741382957 ], [ 1389428.692968821851537, 5859524.248876142315567 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 976.29998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 973.79998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_42_generated", "manhole_dn": "manhole_43_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389428.692968821851537, 5859524.248876142315567 ], [ 1389461.138921525795013, 5859486.477508954703808 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_43_generated", "manhole_dn": "manhole_44_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389461.138921525795013, 5859486.477508954703808 ], [ 1389482.45163832209073, 5859441.487986368127167 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_44_generated", "manhole_dn": "manhole_45_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389482.45163832209073, 5859441.487986368127167 ], [ 1389497.215460168197751, 5859393.906833835877478 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_45_generated", "manhole_dn": "manhole_46_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389497.215460168197751, 5859393.906833835877478 ], [ 1389508.394423164660111, 5859345.216126504354179 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 954.79998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_46_generated", "manhole_dn": "manhole_47_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389508.394423164660111, 5859345.216126504354179 ], [ 1389518.522437864448875, 5859296.29671473056078 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 954.79998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_47_generated", "manhole_dn": "manhole_48_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389518.522437864448875, 5859296.29671473056078 ], [ 1389528.588071504374966, 5859247.363727764226496 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 950.20001220703125, "invlev_up": 954.79998779296875, "invlev_dn": 947.70001220703125, "manhole_up": "manhole_48_generated", "manhole_dn": "manhole_49_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389528.588071504374966, 5859247.363727764226496 ], [ 1389538.653705144301057, 5859198.43074079696089 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 950.20001220703125, "elevtn_dn": 957.60003662109375, "invlev_up": 947.70001220703125, "invlev_dn": 955.10003662109375, "manhole_up": "manhole_49_generated", "manhole_dn": "manhole_50_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389538.653705144301057, 5859198.43074079696089 ], [ 1389548.719338784459978, 5859149.497753830626607 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.60003662109375, "elevtn_dn": 957.60003662109375, "invlev_up": 955.10003662109375, "invlev_dn": 955.10003662109375, "manhole_up": "manhole_50_generated", "manhole_dn": "manhole_51_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389548.719338784459978, 5859149.497753830626607 ], [ 1389558.784972424386069, 5859100.564766863361001 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.60003662109375, "elevtn_dn": 954.79998779296875, "invlev_up": 955.10003662109375, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_51_generated", "manhole_dn": "manhole_52_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389558.784972424386069, 5859100.564766863361001 ], [ 1389568.85060606431216, 5859051.631779897026718 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 954.79998779296875, "invlev_up": 952.29998779296875, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_52_generated", "manhole_dn": "manhole_53_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389568.85060606431216, 5859051.631779897026718 ], [ 1389578.916239704471081, 5859002.698792929761112 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 954.79998779296875, "invlev_up": 952.29998779296875, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_53_generated", "manhole_dn": "manhole_54_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389578.916239704471081, 5859002.698792929761112 ], [ 1389588.981873344397172, 5858953.765805963426828 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 956.10003662109375, "invlev_up": 952.29998779296875, "invlev_dn": 953.60003662109375, "manhole_up": "manhole_54_generated", "manhole_dn": "manhole_55_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389588.981873344397172, 5858953.765805963426828 ], [ 1389599.047506984323263, 5858904.832818996161222 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 956.10003662109375, "elevtn_dn": 956.10003662109375, "invlev_up": 953.60003662109375, "invlev_dn": 953.60003662109375, "manhole_up": "manhole_55_generated", "manhole_dn": "manhole_56_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389599.047506984323263, 5858904.832818996161222 ], [ 1389613.243873829254881, 5858857.048414096236229 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 956.10003662109375, "elevtn_dn": 966.29998779296875, "invlev_up": 953.60003662109375, "invlev_dn": 963.79998779296875, "manhole_up": "manhole_56_generated", "manhole_dn": "manhole_57_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389613.243873829254881, 5858857.048414096236229 ], [ 1389631.198101107496768, 5858810.554778259247541 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 966.29998779296875, "elevtn_dn": 968.70001220703125, "invlev_up": 963.79998779296875, "invlev_dn": 966.20001220703125, "manhole_up": "manhole_57_generated", "manhole_dn": "manhole_58_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389631.198101107496768, 5858810.554778259247541 ], [ 1389656.490605737781152, 5858767.472956065088511 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.70001220703125, "elevtn_dn": 968.70001220703125, "invlev_up": 966.20001220703125, "invlev_dn": 966.20001220703125, "manhole_up": "manhole_58_generated", "manhole_dn": "manhole_59_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389656.490605737781152, 5858767.472956065088511 ], [ 1389681.956975018838421, 5858724.49639992788434 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.70001220703125, "elevtn_dn": 976.10003662109375, "invlev_up": 966.20001220703125, "invlev_dn": 973.60003662109375, "manhole_up": "manhole_59_generated", "manhole_dn": "manhole_60_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389681.956975018838421, 5858724.49639992788434 ], [ 1389708.407580326776952, 5858682.115747822448611 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 976.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 973.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_60_generated", "manhole_dn": "manhole_61_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389708.407580326776952, 5858682.115747822448611 ], [ 1389734.858185634715483, 5858639.735095717012882 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 980.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_61_generated", "manhole_dn": "manhole_62_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389734.858185634715483, 5858639.735095717012882 ], [ 1389761.308790942654014, 5858597.354443610645831 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 980.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_62_generated", "manhole_dn": "manhole_63_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389761.308790942654014, 5858597.354443610645831 ], [ 1389787.759396250825375, 5858554.973791505210102 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 993.29998779296875, "invlev_up": 980.60003662109375, "invlev_dn": 990.79998779296875, "manhole_up": "manhole_63_generated", "manhole_dn": "manhole_64_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389787.759396250825375, 5858554.973791505210102 ], [ 1389814.210001558763906, 5858512.593139399774373 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 993.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 990.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_64_generated", "manhole_dn": "manhole_65_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389814.210001558763906, 5858512.593139399774373 ], [ 1389840.660606866702437, 5858470.212487293407321 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 995.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_65_generated", "manhole_dn": "manhole_66_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389840.660606866702437, 5858470.212487293407321 ], [ 1389867.111212174640968, 5858427.831835187971592 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 995.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_66_generated", "manhole_dn": "manhole_67_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389867.111212174640968, 5858427.831835187971592 ], [ 1389911.240854029776528, 5858417.074701879173517 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 1006.2000122070312, "invlev_up": 995.79998779296875, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_67_generated", "manhole_dn": "manhole_68_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389911.240854029776528, 5858417.074701879173517 ], [ 1389940.226093058940023, 5858455.739661679603159 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E48", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1006.2000122070312, "invlev_up": 1003.7000122070312, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_68_generated", "manhole_dn": "manhole_69_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389940.226093058940023, 5858455.739661679603159 ], [ 1389959.842267287895083, 5858501.684845351614058 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E49", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1006.2000122070312, "invlev_up": 1003.7000122070312, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_69_generated", "manhole_dn": "manhole_70_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389959.842267287895083, 5858501.684845351614058 ], [ 1389983.028926897095516, 5858544.760824581608176 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E50", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1036.9000244140625, "invlev_up": 1003.7000122070312, "invlev_dn": 1034.4000244140625, "manhole_up": "manhole_70_generated", "manhole_dn": "manhole_71_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389983.028926897095516, 5858544.760824581608176 ], [ 1390026.879799408372492, 5858567.986969069577754 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E51", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1036.9000244140625, "elevtn_dn": 1036.9000244140625, "invlev_up": 1034.4000244140625, "invlev_dn": 1034.4000244140625, "manhole_up": "manhole_71_generated", "manhole_dn": "manhole_72_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390026.879799408372492, 5858567.986969069577754 ], [ 1390075.455719914287329, 5858577.981817713007331 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E52", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1036.9000244140625, "elevtn_dn": 1032.9000244140625, "invlev_up": 1034.4000244140625, "invlev_dn": 1030.4000244140625, "manhole_up": "manhole_72_generated", "manhole_dn": "manhole_73_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390075.455719914287329, 5858577.981817713007331 ], [ 1390124.934819511603564, 5858584.860858413390815 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E53", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1032.9000244140625, "elevtn_dn": 1032.9000244140625, "invlev_up": 1030.4000244140625, "invlev_dn": 1030.4000244140625, "manhole_up": "manhole_73_generated", "manhole_dn": "manhole_74_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390124.934819511603564, 5858584.860858413390815 ], [ 1390174.385966305155307, 5858591.894069475121796 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E54", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1032.9000244140625, "elevtn_dn": 1016.6000366210938, "invlev_up": 1030.4000244140625, "invlev_dn": 1014.1000366210938, "manhole_up": "manhole_74_generated", "manhole_dn": "manhole_75_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390174.385966305155307, 5858591.894069475121796 ], [ 1390224.28731826832518, 5858594.262458441779017 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E55", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1016.6000366210938, "elevtn_dn": 1016.6000366210938, "invlev_up": 1014.1000366210938, "invlev_dn": 1014.1000366210938, "manhole_up": "manhole_75_generated", "manhole_dn": "manhole_76_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390224.28731826832518, 5858594.262458441779017 ], [ 1390273.630285855382681, 5858589.561945637688041 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E56", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1016.6000366210938, "elevtn_dn": 1012.1000366210938, "invlev_up": 1014.1000366210938, "invlev_dn": 1009.6000366210938, "manhole_up": "manhole_76_generated", "manhole_dn": "manhole_77_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390273.630285855382681, 5858589.561945637688041 ], [ 1390322.239480242831632, 5858578.072306710295379 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E57", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1012.1000366210938, "elevtn_dn": 1012.1000366210938, "invlev_up": 1009.6000366210938, "invlev_dn": 1009.6000366210938, "manhole_up": "manhole_77_generated", "manhole_dn": "manhole_78_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390322.239480242831632, 5858578.072306710295379 ], [ 1390371.99352877959609, 5858575.309522898867726 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E58", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1012.1000366210938, "elevtn_dn": 1011.7000122070312, "invlev_up": 1009.6000366210938, "invlev_dn": 1009.2000122070312, "manhole_up": "manhole_78_generated", "manhole_dn": "manhole_79_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390371.99352877959609, 5858575.309522898867726 ], [ 1390419.13544210139662, 5858559.59311543405056 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E59", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1011.7000122070312, "elevtn_dn": 981.5, "invlev_up": 1009.2000122070312, "invlev_dn": 979.0, "manhole_up": "manhole_79_generated", "manhole_dn": "manhole_80_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390419.13544210139662, 5858559.59311543405056 ], [ 1390453.401623640675098, 5858524.246223840862513 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E60", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 981.5, "elevtn_dn": 995.70001220703125, "invlev_up": 979.0, "invlev_dn": 993.20001220703125, "manhole_up": "manhole_80_generated", "manhole_dn": "manhole_81_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390453.401623640675098, 5858524.246223840862513 ], [ 1390496.749499944737181, 5858504.780008735135198 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E61", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 995.70001220703125, "elevtn_dn": 995.70001220703125, "invlev_up": 993.20001220703125, "invlev_dn": 993.20001220703125, "manhole_up": "manhole_81_generated", "manhole_dn": "manhole_82_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390496.749499944737181, 5858504.780008735135198 ], [ 1390546.470755147282034, 5858499.993151630274951 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E62", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 995.70001220703125, "elevtn_dn": 1005.9000244140625, "invlev_up": 993.20001220703125, "invlev_dn": 1003.4000244140625, "manhole_up": "manhole_82_generated", "manhole_dn": "manhole_83_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390546.470755147282034, 5858499.993151630274951 ], [ 1390596.395264241611585, 5858498.177226040512323 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E63", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1005.9000244140625, "elevtn_dn": 1005.9000244140625, "invlev_up": 1003.4000244140625, "invlev_dn": 1003.4000244140625, "manhole_up": "manhole_83_generated", "manhole_dn": "manhole_84_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390596.395264241611585, 5858498.177226040512323 ], [ 1390646.319773336173967, 5858496.361300451681018 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E64", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1005.9000244140625, "elevtn_dn": 1013.6000366210938, "invlev_up": 1003.4000244140625, "invlev_dn": 1011.1000366210938, "manhole_up": "manhole_84_generated", "manhole_dn": "manhole_85_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390646.319773336173967, 5858496.361300451681018 ], [ 1390696.244282430503517, 5858494.545374862849712 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E65", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1013.6000366210938, "elevtn_dn": 1013.6000366210938, "invlev_up": 1011.1000366210938, "invlev_dn": 1011.1000366210938, "manhole_up": "manhole_85_generated", "manhole_dn": "manhole_86_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390696.244282430503517, 5858494.545374862849712 ], [ 1390746.168791524833068, 5858492.729449273087084 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E66", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1013.6000366210938, "elevtn_dn": 1019.1000366210938, "invlev_up": 1011.1000366210938, "invlev_dn": 1016.6000366210938, "manhole_up": "manhole_86_generated", "manhole_dn": "manhole_87_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390746.168791524833068, 5858492.729449273087084 ], [ 1390796.09330061939545, 5858490.913523684255779 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E67", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1019.1000366210938, "elevtn_dn": 1025.800048828125, "invlev_up": 1016.6000366210938, "invlev_dn": 1023.300048828125, "manhole_up": "manhole_87_generated", "manhole_dn": "manhole_88_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390796.09330061939545, 5858490.913523684255779 ], [ 1390846.017809713725001, 5858489.097598095424473 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E68", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1025.800048828125, "elevtn_dn": 1025.800048828125, "invlev_up": 1023.300048828125, "invlev_dn": 1023.300048828125, "manhole_up": "manhole_88_generated", "manhole_dn": "manhole_89_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390846.017809713725001, 5858489.097598095424473 ], [ 1390895.942318808054551, 5858487.281672505661845 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E69", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1025.800048828125, "elevtn_dn": 1029.2000732421875, "invlev_up": 1023.300048828125, "invlev_dn": 1026.7000732421875, "manhole_up": "manhole_89_generated", "manhole_dn": "manhole_90_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390895.942318808054551, 5858487.281672505661845 ], [ 1390945.364988021552563, 5858492.061225635930896 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E70", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1029.2000732421875, "elevtn_dn": 1029.2000732421875, "invlev_up": 1026.7000732421875, "invlev_dn": 1026.7000732421875, "manhole_up": "manhole_90_generated", "manhole_dn": "manhole_91_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390945.364988021552563, 5858492.061225635930896 ], [ 1390994.440001817885786, 5858501.409873396158218 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E71", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1029.2000732421875, "elevtn_dn": 1033.2000732421875, "invlev_up": 1026.7000732421875, "invlev_dn": 1030.7000732421875, "manhole_up": "manhole_91_generated", "manhole_dn": "manhole_92_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390994.440001817885786, 5858501.409873396158218 ], [ 1391040.341196772176772, 5858520.979841153137386 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E72", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1033.2000732421875, "elevtn_dn": 1033.2000732421875, "invlev_up": 1030.7000732421875, "invlev_dn": 1030.7000732421875, "manhole_up": "manhole_92_generated", "manhole_dn": "manhole_93_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391040.341196772176772, 5858520.979841153137386 ], [ 1391086.683747049886733, 5858538.717575071379542 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E73", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1033.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1030.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_93_generated", "manhole_dn": "manhole_94_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391086.683747049886733, 5858538.717575071379542 ], [ 1391131.822940095094964, 5858523.93243224080652 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E74", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_94_generated", "manhole_dn": "manhole_95_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391131.822940095094964, 5858523.93243224080652 ], [ 1391153.157672074623406, 5858479.460670891217887 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E75", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_95_generated", "manhole_dn": "manhole_96_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391153.157672074623406, 5858479.460670891217887 ], [ 1391192.49590603238903, 5858451.67839205916971 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E76", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1044.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1041.7000732421875, "manhole_up": "manhole_96_generated", "manhole_dn": "manhole_97_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391192.49590603238903, 5858451.67839205916971 ], [ 1391240.64117361814715, 5858438.460245226509869 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E77", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1044.2000732421875, "elevtn_dn": 1044.2000732421875, "invlev_up": 1041.7000732421875, "invlev_dn": 1041.7000732421875, "manhole_up": "manhole_97_generated", "manhole_dn": "manhole_98_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391240.64117361814715, 5858438.460245226509869 ], [ 1391289.211760010803118, 5858426.770406410098076 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E78", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1044.2000732421875, "elevtn_dn": 1060.0999755859375, "invlev_up": 1041.7000732421875, "invlev_dn": 1057.5999755859375, "manhole_up": "manhole_98_generated", "manhole_dn": "manhole_99_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391289.211760010803118, 5858426.770406410098076 ], [ 1391337.782346403226256, 5858415.080567593686283 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E79", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1060.0999755859375, "elevtn_dn": 1023.0, "invlev_up": 1057.5999755859375, "invlev_dn": 1020.5, "manhole_up": "manhole_99_generated", "manhole_dn": "manhole_100_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391337.782346403226256, 5858415.080567593686283 ], [ 1391386.352932795882225, 5858403.390728777274489 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E80", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1023.0, "elevtn_dn": 1032.7000732421875, "invlev_up": 1020.5, "invlev_dn": 1030.2000732421875, "manhole_up": "manhole_100_generated", "manhole_dn": "manhole_101_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391386.352932795882225, 5858403.390728777274489 ], [ 1391434.923519188305363, 5858391.700889961794019 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E81", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1032.7000732421875, "elevtn_dn": 1032.7000732421875, "invlev_up": 1030.2000732421875, "invlev_dn": 1030.2000732421875, "manhole_up": "manhole_101_generated", "manhole_dn": "manhole_102_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391434.923519188305363, 5858391.700889961794019 ], [ 1391483.494105580961332, 5858380.011051145382226 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E82", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1032.7000732421875, "elevtn_dn": 1040.7000732421875, "invlev_up": 1030.2000732421875, "invlev_dn": 1038.2000732421875, "manhole_up": "manhole_102_generated", "manhole_dn": "manhole_103_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391483.494105580961332, 5858380.011051145382226 ], [ 1391532.464345134794712, 5858375.802092345431447 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E83", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1040.7000732421875, "elevtn_dn": 1040.7000732421875, "invlev_up": 1038.2000732421875, "invlev_dn": 1038.2000732421875, "manhole_up": "manhole_103_generated", "manhole_dn": "manhole_104_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391532.464345134794712, 5858375.802092345431447 ], [ 1391579.680508555145934, 5858389.753166117705405 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E84", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1040.7000732421875, "elevtn_dn": 1094.5999755859375, "invlev_up": 1038.2000732421875, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_104_generated", "manhole_dn": "manhole_105_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391579.680508555145934, 5858389.753166117705405 ], [ 1391615.043221722124144, 5858422.374543751589954 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E85", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1094.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_105_generated", "manhole_dn": "manhole_106_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391615.043221722124144, 5858422.374543751589954 ], [ 1391633.654095822479576, 5858468.206737855449319 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E86", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1094.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_106_generated", "manhole_dn": "manhole_107_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391633.654095822479576, 5858468.206737855449319 ], [ 1391675.556871910346672, 5858492.042518986389041 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E87", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1100.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1098.0999755859375, "manhole_up": "manhole_107_generated", "manhole_dn": "manhole_108_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391675.556871910346672, 5858492.042518986389041 ], [ 1391725.165284683462232, 5858493.223410680890083 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E88", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1100.5999755859375, "elevtn_dn": 1092.7000732421875, "invlev_up": 1098.0999755859375, "invlev_dn": 1090.2000732421875, "manhole_up": "manhole_108_generated", "manhole_dn": "manhole_109_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391725.165284683462232, 5858493.223410680890083 ], [ 1391774.025632579578087, 5858482.968163449317217 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E89", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1092.7000732421875, "elevtn_dn": 1092.7000732421875, "invlev_up": 1090.2000732421875, "invlev_dn": 1090.2000732421875, "manhole_up": "manhole_109_generated", "manhole_dn": "manhole_110_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391774.025632579578087, 5858482.968163449317217 ], [ 1391822.748904443578795, 5858472.800456050783396 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E90", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1092.7000732421875, "elevtn_dn": 1086.5, "invlev_up": 1090.2000732421875, "invlev_dn": 1084.0, "manhole_up": "manhole_110_generated", "manhole_dn": "manhole_111_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391822.748904443578795, 5858472.800456050783396 ], [ 1391872.520155652426183, 5858474.254766616038978 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E91", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1086.5, "elevtn_dn": 1086.5, "invlev_up": 1084.0, "invlev_dn": 1084.0, "manhole_up": "manhole_111_generated", "manhole_dn": "manhole_112_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391872.520155652426183, 5858474.254766616038978 ], [ 1391922.32820742437616, 5858478.116394865326583 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E92", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1086.5, "elevtn_dn": 1097.300048828125, "invlev_up": 1084.0, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_112_generated", "manhole_dn": "manhole_113_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391922.32820742437616, 5858478.116394865326583 ], [ 1391972.136259196558967, 5858481.978023114614189 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E93", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_113_generated", "manhole_dn": "manhole_114_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391972.136259196558967, 5858481.978023114614189 ], [ 1392014.088137687649578, 5858507.265420926734805 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E94", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_114_generated", "manhole_dn": "manhole_115_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392014.088137687649578, 5858507.265420926734805 ], [ 1392052.00577615830116, 5858538.949620860628784 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E95", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_115_generated", "manhole_dn": "manhole_116_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392052.00577615830116, 5858538.949620860628784 ], [ 1392100.993319420609623, 5858548.746293722651899 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E96", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1135.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1132.800048828125, "manhole_up": "manhole_116_generated", "manhole_dn": "manhole_117_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392100.993319420609623, 5858548.746293722651899 ], [ 1392149.980862683150917, 5858558.542966585606337 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E97", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1135.300048828125, "elevtn_dn": 1135.300048828125, "invlev_up": 1132.800048828125, "invlev_dn": 1132.800048828125, "manhole_up": "manhole_117_generated", "manhole_dn": "manhole_118_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392149.980862683150917, 5858558.542966585606337 ], [ 1392198.767287699971348, 5858569.25206732749939 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E98", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1135.300048828125, "elevtn_dn": 1137.5999755859375, "invlev_up": 1132.800048828125, "invlev_dn": 1135.0999755859375, "manhole_up": "manhole_118_generated", "manhole_dn": "manhole_119_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392198.767287699971348, 5858569.25206732749939 ], [ 1392247.333906656363979, 5858580.958378325216472 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E99", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1137.5999755859375, "elevtn_dn": 1137.5999755859375, "invlev_up": 1135.0999755859375, "invlev_dn": 1135.0999755859375, "manhole_up": "manhole_119_generated", "manhole_dn": "manhole_120_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392247.333906656363979, 5858580.958378325216472 ], [ 1392295.900525612989441, 5858592.664689323864877 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E100", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1137.5999755859375, "elevtn_dn": 1145.0999755859375, "invlev_up": 1135.0999755859375, "invlev_dn": 1142.5999755859375, "manhole_up": "manhole_120_generated", "manhole_dn": "manhole_121_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392295.900525612989441, 5858592.664689323864877 ], [ 1392344.467144569614902, 5858604.371000322513282 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E101", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1145.0999755859375, "elevtn_dn": 1145.0999755859375, "invlev_up": 1142.5999755859375, "invlev_dn": 1142.5999755859375, "manhole_up": "manhole_121_generated", "manhole_dn": "manhole_122_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392344.467144569614902, 5858604.371000322513282 ], [ 1392389.908255772199482, 5858624.575613909401 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E102", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1145.0999755859375, "elevtn_dn": 1140.5, "invlev_up": 1142.5999755859375, "invlev_dn": 1138.0, "manhole_up": "manhole_122_generated", "manhole_dn": "manhole_123_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392389.908255772199482, 5858624.575613909401 ], [ 1392425.081700494978577, 5858659.315580372698605 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E103", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1140.5, "elevtn_dn": 1169.300048828125, "invlev_up": 1138.0, "invlev_dn": 1166.800048828125, "manhole_up": "manhole_123_generated", "manhole_dn": "manhole_124_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392425.081700494978577, 5858659.315580372698605 ], [ 1392458.203119478421286, 5858696.715123130939901 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E104", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.300048828125, "elevtn_dn": 1169.300048828125, "invlev_up": 1166.800048828125, "invlev_dn": 1166.800048828125, "manhole_up": "manhole_124_generated", "manhole_dn": "manhole_125_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392458.203119478421286, 5858696.715123130939901 ], [ 1392491.324538461863995, 5858734.114665890112519 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E105", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.300048828125, "elevtn_dn": 1165.5, "invlev_up": 1166.800048828125, "invlev_dn": 1163.0, "manhole_up": "manhole_125_generated", "manhole_dn": "manhole_126_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392491.324538461863995, 5858734.114665890112519 ], [ 1392528.963966277893633, 5858766.460637149401009 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E106", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1165.5, "elevtn_dn": 1165.5, "invlev_up": 1163.0, "invlev_dn": 1163.0, "manhole_up": "manhole_126_generated", "manhole_dn": "manhole_127_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392528.963966277893633, 5858766.460637149401009 ], [ 1392573.284122244687751, 5858789.391092935577035 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E107", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1165.5, "elevtn_dn": 1157.0999755859375, "invlev_up": 1163.0, "invlev_dn": 1154.5999755859375, "manhole_up": "manhole_127_generated", "manhole_dn": "manhole_128_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392573.284122244687751, 5858789.391092935577035 ], [ 1392618.033192394766957, 5858811.600886153057218 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E108", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1157.0999755859375, "elevtn_dn": 1184.800048828125, "invlev_up": 1154.5999755859375, "invlev_dn": 1182.300048828125, "manhole_up": "manhole_128_generated", "manhole_dn": "manhole_129_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392618.033192394766957, 5858811.600886153057218 ], [ 1392666.730896146036685, 5858821.011833874508739 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E109", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1184.800048828125, "elevtn_dn": 1141.2000732421875, "invlev_up": 1182.300048828125, "invlev_dn": 1138.7000732421875, "manhole_up": "manhole_129_generated", "manhole_dn": "manhole_130_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392666.730896146036685, 5858821.011833874508739 ], [ 1392714.397227015113458, 5858809.184477739967406 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E110", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1141.2000732421875, "elevtn_dn": 1141.2000732421875, "invlev_up": 1138.7000732421875, "invlev_dn": 1138.7000732421875, "manhole_up": "manhole_130_generated", "manhole_dn": "manhole_131_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392714.397227015113458, 5858809.184477739967406 ], [ 1392761.799294820055366, 5858794.231293976306915 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E111", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1141.2000732421875, "elevtn_dn": 1137.4000244140625, "invlev_up": 1138.7000732421875, "invlev_dn": 1134.9000244140625, "manhole_up": "manhole_131_generated", "manhole_dn": "manhole_132_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392761.799294820055366, 5858794.231293976306915 ], [ 1392810.095712865469977, 5858797.830352782271802 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E112", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1137.4000244140625, "elevtn_dn": 1137.4000244140625, "invlev_up": 1134.9000244140625, "invlev_dn": 1134.9000244140625, "manhole_up": "manhole_132_generated", "manhole_dn": "manhole_133_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392810.095712865469977, 5858797.830352782271802 ], [ 1392855.660074200481176, 5858817.529770986177027 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E113", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1137.4000244140625, "elevtn_dn": 1169.5, "invlev_up": 1134.9000244140625, "invlev_dn": 1167.0, "manhole_up": "manhole_133_generated", "manhole_dn": "manhole_134_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392855.660074200481176, 5858817.529770986177027 ], [ 1392904.672455, 5858826.347064822912216 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E114", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_134_generated", "manhole_dn": "manhole_135_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392904.672455, 5858826.347064822912216 ], [ 1392949.505032581742853, 5858846.393358059227467 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E115", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_135_generated", "manhole_dn": "manhole_136_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392949.505032581742853, 5858846.393358059227467 ], [ 1392993.956312821945176, 5858868.358838438987732 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E116", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_136_generated", "manhole_dn": "manhole_137_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392993.956312821945176, 5858868.358838438987732 ], [ 1393042.160067020915449, 5858881.479519641026855 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E117", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1162.0, "invlev_up": 1167.0, "invlev_dn": 1159.5, "manhole_up": "manhole_137_generated", "manhole_dn": "manhole_138_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393042.160067020915449, 5858881.479519641026855 ], [ 1393090.363821219652891, 5858894.600200843065977 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E118", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1162.0, "elevtn_dn": 1162.0, "invlev_up": 1159.5, "invlev_dn": 1159.5, "manhole_up": "manhole_138_generated", "manhole_dn": "manhole_139_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393090.363821219652891, 5858894.600200843065977 ], [ 1393138.877780271228403, 5858905.382868006825447 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E119", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1162.0, "elevtn_dn": 1152.0999755859375, "invlev_up": 1159.5, "invlev_dn": 1149.5999755859375, "manhole_up": "manhole_139_generated", "manhole_dn": "manhole_140_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393138.877780271228403, 5858905.382868006825447 ], [ 1393188.835210436256602, 5858905.286093098111451 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E120", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1152.0999755859375, "elevtn_dn": 1152.0999755859375, "invlev_up": 1149.5999755859375, "invlev_dn": 1149.5999755859375, "manhole_up": "manhole_140_generated", "manhole_dn": "manhole_141_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393188.835210436256602, 5858905.286093098111451 ], [ 1393237.248238409170881, 5858916.599204055964947 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E121", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1152.0999755859375, "elevtn_dn": 1147.300048828125, "invlev_up": 1149.5999755859375, "invlev_dn": 1144.800048828125, "manhole_up": "manhole_141_generated", "manhole_dn": "manhole_142_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393237.248238409170881, 5858916.599204055964947 ], [ 1393278.15638761385344, 5858943.766047672368586 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E122", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1147.300048828125, "elevtn_dn": 1182.7000732421875, "invlev_up": 1144.800048828125, "invlev_dn": 1180.2000732421875, "manhole_up": "manhole_142_generated", "manhole_dn": "manhole_143_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393278.15638761385344, 5858943.766047672368586 ], [ 1393316.553906054003164, 5858975.725158606655896 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E123", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1182.7000732421875, "elevtn_dn": 1180.0999755859375, "invlev_up": 1180.2000732421875, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_143_generated", "manhole_dn": "manhole_144_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393316.553906054003164, 5858975.725158606655896 ], [ 1393354.951424494385719, 5859007.684269540011883 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E124", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1180.0999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_144_generated", "manhole_dn": "manhole_145_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393354.951424494385719, 5859007.684269540011883 ], [ 1393393.348942934535444, 5859039.643380474299192 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E125", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1180.0999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_145_generated", "manhole_dn": "manhole_146_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393393.348942934535444, 5859039.643380474299192 ], [ 1393431.746461374685168, 5859071.602491408586502 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E126", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_146_generated", "manhole_dn": "manhole_147_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393431.746461374685168, 5859071.602491408586502 ], [ 1393472.672340910183266, 5859100.089053857140243 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E127", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1200.0999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_147_generated", "manhole_dn": "manhole_148_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393472.672340910183266, 5859100.089053857140243 ], [ 1393507.678647378925234, 5859134.262682756409049 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E128", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1200.0999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_148_generated", "manhole_dn": "manhole_149_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393507.678647378925234, 5859134.262682756409049 ], [ 1393492.637579936999828, 5859179.667013085447252 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E129", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1232.300048828125, "invlev_up": 1200.0999755859375, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_149_generated", "manhole_dn": "manhole_150_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393492.637579936999828, 5859179.667013085447252 ], [ 1393472.727902054553851, 5859225.064155456610024 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E130", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_150_generated", "manhole_dn": "manhole_151_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393472.727902054553851, 5859225.064155456610024 ], [ 1393467.563765458529815, 5859274.587596206925809 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E131", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_151_generated", "manhole_dn": "manhole_152_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393467.563765458529815, 5859274.587596206925809 ], [ 1393473.51405850565061, 5859323.8850102070719 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E132", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_152_generated", "manhole_dn": "manhole_153_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393473.51405850565061, 5859323.8850102070719 ], [ 1393507.773820924572647, 5859356.614802500233054 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E133", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1214.800048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1212.300048828125, "manhole_up": "manhole_153_generated", "manhole_dn": "manhole_154_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393507.773820924572647, 5859356.614802500233054 ], [ 1393555.824224345618859, 5859349.253152369521558 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E134", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1214.800048828125, "elevtn_dn": 1214.800048828125, "invlev_up": 1212.300048828125, "invlev_dn": 1212.300048828125, "manhole_up": "manhole_154_generated", "manhole_dn": "manhole_155_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393555.824224345618859, 5859349.253152369521558 ], [ 1393591.00338595919311, 5859314.794959847815335 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E135", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1214.800048828125, "elevtn_dn": 1191.0999755859375, "invlev_up": 1212.300048828125, "invlev_dn": 1188.5999755859375, "manhole_up": "manhole_155_generated", "manhole_dn": "manhole_156_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393591.00338595919311, 5859314.794959847815335 ], [ 1393633.153639519121498, 5859288.066565420478582 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E136", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1191.0999755859375, "elevtn_dn": 1191.0999755859375, "invlev_up": 1188.5999755859375, "invlev_dn": 1188.5999755859375, "manhole_up": "manhole_156_generated", "manhole_dn": "manhole_157_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393633.153639519121498, 5859288.066565420478582 ], [ 1393673.123904188396409, 5859258.097712650895119 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E137", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1191.0999755859375, "elevtn_dn": 1144.300048828125, "invlev_up": 1188.5999755859375, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_157_generated", "manhole_dn": "manhole_158_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393673.123904188396409, 5859258.097712650895119 ], [ 1393720.523227575467899, 5859244.838272913359106 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E138", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1144.300048828125, "invlev_up": 1141.800048828125, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_158_generated", "manhole_dn": "manhole_159_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393720.523227575467899, 5859244.838272913359106 ], [ 1393765.710014625452459, 5859224.569284616038203 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E139", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1144.300048828125, "invlev_up": 1141.800048828125, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_159_generated", "manhole_dn": "manhole_160_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393765.710014625452459, 5859224.569284616038203 ], [ 1393806.409210936399177, 5859195.609256223775446 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_8_E140", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_8", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1112.5, "invlev_up": 1141.800048828125, "invlev_dn": 1110.0, "manhole_up": "manhole_160_generated", "manhole_dn": "manhole_161_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393806.409210936399177, 5859195.609256223775446 ], [ 1393846.866742686368525, 5859166.301538489758968 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1045", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 968.29998779296875, "invlev_up": 965.79998779296875, "invlev_dn": 965.79998779296875, "manhole_up": "manhole_162_generated", "manhole_dn": "manhole_163_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388521.257592596346512, 5855362.027613477781415 ], [ 1388472.030306826578453, 5855370.543775821104646 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1046", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 968.29998779296875, "invlev_up": 965.79998779296875, "invlev_dn": 965.79998779296875, "manhole_up": "manhole_163_generated", "manhole_dn": "manhole_164_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388472.030306826578453, 5855370.543775821104646 ], [ 1388439.000347282737494, 5855407.802592809312046 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1047", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 964.5, "invlev_up": 965.79998779296875, "invlev_dn": 962.0, "manhole_up": "manhole_164_generated", "manhole_dn": "manhole_165_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388439.000347282737494, 5855407.802592809312046 ], [ 1388400.196091859601438, 5855436.014134516008198 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1048", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 964.5, "invlev_up": 962.0, "invlev_dn": 962.0, "manhole_up": "manhole_165_generated", "manhole_dn": "manhole_166_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388400.196091859601438, 5855436.014134516008198 ], [ 1388351.33823574683629, 5855446.634319253265858 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1049", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 981.9000244140625, "invlev_up": 962.0, "invlev_dn": 979.4000244140625, "manhole_up": "manhole_166_generated", "manhole_dn": "manhole_167_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388351.33823574683629, 5855446.634319253265858 ], [ 1388301.961881892289966, 5855453.847477887757123 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1050", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 981.9000244140625, "elevtn_dn": 981.9000244140625, "invlev_up": 979.4000244140625, "invlev_dn": 979.4000244140625, "manhole_up": "manhole_167_generated", "manhole_dn": "manhole_168_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388301.961881892289966, 5855453.847477887757123 ], [ 1388252.297577269142494, 5855451.260453455150127 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1051", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 981.9000244140625, "elevtn_dn": 973.70001220703125, "invlev_up": 979.4000244140625, "invlev_dn": 971.20001220703125, "manhole_up": "manhole_168_generated", "manhole_dn": "manhole_169_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388252.297577269142494, 5855451.260453455150127 ], [ 1388202.479659734526649, 5855455.508814659900963 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1052", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 973.70001220703125, "elevtn_dn": 961.70001220703125, "invlev_up": 971.20001220703125, "invlev_dn": 959.20001220703125, "manhole_up": "manhole_169_generated", "manhole_dn": "manhole_170_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388202.479659734526649, 5855455.508814659900963 ], [ 1388152.683455461403355, 5855460.015516467392445 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1053", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 961.70001220703125, "elevtn_dn": 961.70001220703125, "invlev_up": 959.20001220703125, "invlev_dn": 959.20001220703125, "manhole_up": "manhole_170_generated", "manhole_dn": "manhole_171_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388152.683455461403355, 5855460.015516467392445 ], [ 1388104.622611842118204, 5855473.253733876161277 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1054", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 961.70001220703125, "elevtn_dn": 945.79998779296875, "invlev_up": 959.20001220703125, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_171_generated", "manhole_dn": "manhole_172_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388104.622611842118204, 5855473.253733876161277 ], [ 1388057.00563437351957, 5855488.445189393125474 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1055", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 945.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_172_generated", "manhole_dn": "manhole_173_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388057.00563437351957, 5855488.445189393125474 ], [ 1388011.292356542311609, 5855508.700276436284184 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1056", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 945.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_173_generated", "manhole_dn": "manhole_174_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388011.292356542311609, 5855508.700276436284184 ], [ 1387969.221702651120722, 5855535.246164590120316 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1057", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 930.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 928.29998779296875, "manhole_up": "manhole_174_generated", "manhole_dn": "manhole_175_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.221702651120722, 5855535.246164590120316 ], [ 1387935.863196024205536, 5855572.491061648353934 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1058", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 930.79998779296875, "elevtn_dn": 957.10003662109375, "invlev_up": 928.29998779296875, "invlev_dn": 954.60003662109375, "manhole_up": "manhole_175_generated", "manhole_dn": "manhole_176_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387935.863196024205536, 5855572.491061648353934 ], [ 1387904.610231971368194, 5855611.432584651745856 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1059", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.10003662109375, "elevtn_dn": 947.4000244140625, "invlev_up": 954.60003662109375, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_176_generated", "manhole_dn": "manhole_177_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387904.610231971368194, 5855611.432584651745856 ], [ 1387869.335365027422085, 5855646.852918352000415 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1060", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 947.4000244140625, "invlev_up": 944.9000244140625, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_177_generated", "manhole_dn": "manhole_178_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387869.335365027422085, 5855646.852918352000415 ], [ 1387831.783288773847744, 5855679.735664095729589 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1061", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 947.4000244140625, "invlev_up": 944.9000244140625, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_178_generated", "manhole_dn": "manhole_179_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387831.783288773847744, 5855679.735664095729589 ], [ 1387791.509416193468496, 5855708.923279576934874 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1062", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 933.29998779296875, "invlev_up": 944.9000244140625, "invlev_dn": 930.79998779296875, "manhole_up": "manhole_179_generated", "manhole_dn": "manhole_180_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387791.509416193468496, 5855708.923279576934874 ], [ 1387742.459816947113723, 5855717.213657722808421 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1063", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.29998779296875, "elevtn_dn": 933.29998779296875, "invlev_up": 930.79998779296875, "invlev_dn": 930.79998779296875, "manhole_up": "manhole_180_generated", "manhole_dn": "manhole_181_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387742.459816947113723, 5855717.213657722808421 ], [ 1387692.500367184402421, 5855718.495403698645532 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1064", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.29998779296875, "elevtn_dn": 911.10003662109375, "invlev_up": 930.79998779296875, "invlev_dn": 908.60003662109375, "manhole_up": "manhole_181_generated", "manhole_dn": "manhole_182_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387692.500367184402421, 5855718.495403698645532 ], [ 1387642.500798417022452, 5855718.61967874225229 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1065", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.10003662109375, "elevtn_dn": 887.70001220703125, "invlev_up": 908.60003662109375, "invlev_dn": 885.20001220703125, "manhole_up": "manhole_182_generated", "manhole_dn": "manhole_183_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387642.500798417022452, 5855718.61967874225229 ], [ 1387592.501229649642482, 5855718.743953784927726 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1066", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 887.70001220703125, "elevtn_dn": 887.70001220703125, "invlev_up": 885.20001220703125, "invlev_dn": 885.20001220703125, "manhole_up": "manhole_183_generated", "manhole_dn": "manhole_184_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387592.501229649642482, 5855718.743953784927726 ], [ 1387542.501660882262513, 5855718.868228827603161 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1067", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 887.70001220703125, "elevtn_dn": 902.9000244140625, "invlev_up": 885.20001220703125, "invlev_dn": 900.4000244140625, "manhole_up": "manhole_184_generated", "manhole_dn": "manhole_185_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387542.501660882262513, 5855718.868228827603161 ], [ 1387492.651409652316943, 5855720.815255363471806 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1068", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 902.9000244140625, "elevtn_dn": 902.9000244140625, "invlev_up": 900.4000244140625, "invlev_dn": 900.4000244140625, "manhole_up": "manhole_185_generated", "manhole_dn": "manhole_186_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387492.651409652316943, 5855720.815255363471806 ], [ 1387448.867236748570576, 5855742.752516686916351 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1069", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 902.9000244140625, "elevtn_dn": 886.20001220703125, "invlev_up": 900.4000244140625, "invlev_dn": 883.70001220703125, "manhole_up": "manhole_186_generated", "manhole_dn": "manhole_187_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387448.867236748570576, 5855742.752516686916351 ], [ 1387402.432745414320379, 5855761.091833713464439 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1070", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 886.20001220703125, "elevtn_dn": 886.20001220703125, "invlev_up": 883.70001220703125, "invlev_dn": 883.70001220703125, "manhole_up": "manhole_187_generated", "manhole_dn": "manhole_188_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387402.432745414320379, 5855761.091833713464439 ], [ 1387355.687973388005048, 5855778.837216476909816 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1071", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 886.20001220703125, "elevtn_dn": 879.4000244140625, "invlev_up": 883.70001220703125, "invlev_dn": 876.9000244140625, "manhole_up": "manhole_188_generated", "manhole_dn": "manhole_189_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387355.687973388005048, 5855778.837216476909816 ], [ 1387308.943201361689717, 5855796.582599240355194 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1072", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 879.4000244140625, "elevtn_dn": 879.4000244140625, "invlev_up": 876.9000244140625, "invlev_dn": 876.9000244140625, "manhole_up": "manhole_189_generated", "manhole_dn": "manhole_190_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387308.943201361689717, 5855796.582599240355194 ], [ 1387262.861613623332232, 5855815.656713440082967 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1073", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 879.4000244140625, "elevtn_dn": 873.29998779296875, "invlev_up": 876.9000244140625, "invlev_dn": 870.79998779296875, "manhole_up": "manhole_190_generated", "manhole_dn": "manhole_191_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387262.861613623332232, 5855815.656713440082967 ], [ 1387224.059019178850576, 5855846.996291697025299 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1074", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 873.29998779296875, "elevtn_dn": 938.9000244140625, "invlev_up": 870.79998779296875, "invlev_dn": 936.4000244140625, "manhole_up": "manhole_191_generated", "manhole_dn": "manhole_192_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387224.059019178850576, 5855846.996291697025299 ], [ 1387180.719124856637791, 5855870.194651792757213 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1075", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 938.9000244140625, "elevtn_dn": 932.79998779296875, "invlev_up": 936.4000244140625, "invlev_dn": 930.29998779296875, "manhole_up": "manhole_192_generated", "manhole_dn": "manhole_193_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387180.719124856637791, 5855870.194651792757213 ], [ 1387131.003996425773948, 5855874.064550469629467 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1076", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.79998779296875, "elevtn_dn": 932.79998779296875, "invlev_up": 930.29998779296875, "invlev_dn": 930.29998779296875, "manhole_up": "manhole_193_generated", "manhole_dn": "manhole_194_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387131.003996425773948, 5855874.064550469629467 ], [ 1387081.098878284916282, 5855871.158613862469792 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1077", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.79998779296875, "elevtn_dn": 916.79998779296875, "invlev_up": 930.29998779296875, "invlev_dn": 914.29998779296875, "manhole_up": "manhole_194_generated", "manhole_dn": "manhole_195_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387081.098878284916282, 5855871.158613862469792 ], [ 1387031.198060098802671, 5855868.015261265449226 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1078", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 916.79998779296875, "elevtn_dn": 916.79998779296875, "invlev_up": 914.29998779296875, "invlev_dn": 914.29998779296875, "manhole_up": "manhole_195_generated", "manhole_dn": "manhole_196_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387031.198060098802671, 5855868.015261265449226 ], [ 1386981.297241912456229, 5855864.871908667497337 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1079", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 916.79998779296875, "elevtn_dn": 891.79998779296875, "invlev_up": 914.29998779296875, "invlev_dn": 889.29998779296875, "manhole_up": "manhole_196_generated", "manhole_dn": "manhole_197_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386981.297241912456229, 5855864.871908667497337 ], [ 1386931.47147326474078, 5855860.718019699677825 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1080", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.79998779296875, "elevtn_dn": 891.79998779296875, "invlev_up": 889.29998779296875, "invlev_dn": 889.29998779296875, "manhole_up": "manhole_197_generated", "manhole_dn": "manhole_198_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386931.47147326474078, 5855860.718019699677825 ], [ 1386881.600663758814335, 5855857.577047945931554 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1081", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.79998779296875, "elevtn_dn": 857.10003662109375, "invlev_up": 889.29998779296875, "invlev_dn": 854.60003662109375, "manhole_up": "manhole_198_generated", "manhole_dn": "manhole_199_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386881.600663758814335, 5855857.577047945931554 ], [ 1386832.545593914575875, 5855864.100992278195918 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1082", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 857.10003662109375, "elevtn_dn": 857.10003662109375, "invlev_up": 854.60003662109375, "invlev_dn": 854.60003662109375, "manhole_up": "manhole_199_generated", "manhole_dn": "manhole_200_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386832.545593914575875, 5855864.100992278195918 ], [ 1386787.06764860637486, 5855884.403254445642233 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1083", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 857.10003662109375, "elevtn_dn": 821.29998779296875, "invlev_up": 854.60003662109375, "invlev_dn": 818.79998779296875, "manhole_up": "manhole_200_generated", "manhole_dn": "manhole_201_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386787.06764860637486, 5855884.403254445642233 ], [ 1386748.278358669718727, 5855915.544586268253624 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1084", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 821.29998779296875, "elevtn_dn": 821.29998779296875, "invlev_up": 818.79998779296875, "invlev_dn": 818.79998779296875, "manhole_up": "manhole_201_generated", "manhole_dn": "manhole_202_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386748.278358669718727, 5855915.544586268253624 ], [ 1386721.155419877264649, 5855957.124278785660863 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1085", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 821.29998779296875, "elevtn_dn": 866.0, "invlev_up": 818.79998779296875, "invlev_dn": 863.5, "manhole_up": "manhole_202_generated", "manhole_dn": "manhole_203_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386721.155419877264649, 5855957.124278785660863 ], [ 1386707.750365849817172, 5856004.850832763127983 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1086", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 866.0, "invlev_up": 863.5, "invlev_dn": 863.5, "manhole_up": "manhole_203_generated", "manhole_dn": "manhole_204_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386707.750365849817172, 5856004.850832763127983 ], [ 1386699.832475832896307, 5856054.133603978902102 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1087", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 866.0, "invlev_up": 863.5, "invlev_dn": 863.5, "manhole_up": "manhole_204_generated", "manhole_dn": "manhole_205_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386699.832475832896307, 5856054.133603978902102 ], [ 1386697.095561265014112, 5856103.986880083568394 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1088", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 884.79998779296875, "invlev_up": 863.5, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_205_generated", "manhole_dn": "manhole_206_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386697.095561265014112, 5856103.986880083568394 ], [ 1386699.401158998254687, 5856153.933416903018951 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1089", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 884.79998779296875, "invlev_up": 882.29998779296875, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_206_generated", "manhole_dn": "manhole_207_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386699.401158998254687, 5856153.933416903018951 ], [ 1386715.699191288091242, 5856201.197657831013203 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1090", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 884.79998779296875, "invlev_up": 882.29998779296875, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_207_generated", "manhole_dn": "manhole_208_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386715.699191288091242, 5856201.197657831013203 ], [ 1386741.121203816728666, 5856244.100116757676005 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1091", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 915.9000244140625, "invlev_up": 882.29998779296875, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_208_generated", "manhole_dn": "manhole_209_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386741.121203816728666, 5856244.100116757676005 ], [ 1386774.051378605188802, 5856281.577651324681938 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1092", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_209_generated", "manhole_dn": "manhole_210_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386774.051378605188802, 5856281.577651324681938 ], [ 1386811.583791718119755, 5856314.587093180976808 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1093", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_210_generated", "manhole_dn": "manhole_211_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386811.583791718119755, 5856314.587093180976808 ], [ 1386839.378956499742344, 5856356.087350118905306 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1094", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_211_generated", "manhole_dn": "manhole_212_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386839.378956499742344, 5856356.087350118905306 ], [ 1386855.653891535941511, 5856403.364181768149137 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1095", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_212_generated", "manhole_dn": "manhole_213_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386855.653891535941511, 5856403.364181768149137 ], [ 1386875.714553950354457, 5856449.116945925168693 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1096", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_213_generated", "manhole_dn": "manhole_214_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386875.714553950354457, 5856449.116945925168693 ], [ 1386912.179653002182022, 5856482.939191372133791 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1097", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_214_generated", "manhole_dn": "manhole_215_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386912.179653002182022, 5856482.939191372133791 ], [ 1386944.191176384687424, 5856520.270725904032588 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1098", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 911.79998779296875, "invlev_up": 907.4000244140625, "invlev_dn": 909.29998779296875, "manhole_up": "manhole_215_generated", "manhole_dn": "manhole_216_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386944.191176384687424, 5856520.270725904032588 ], [ 1386964.188513180473819, 5856566.025075756013393 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1099", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.79998779296875, "elevtn_dn": 911.79998779296875, "invlev_up": 909.29998779296875, "invlev_dn": 909.29998779296875, "manhole_up": "manhole_216_generated", "manhole_dn": "manhole_217_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386964.188513180473819, 5856566.025075756013393 ], [ 1386998.825215350603685, 5856599.261941562406719 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1100", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.79998779296875, "elevtn_dn": 932.0, "invlev_up": 909.29998779296875, "invlev_dn": 929.5, "manhole_up": "manhole_217_generated", "manhole_dn": "manhole_218_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386998.825215350603685, 5856599.261941562406719 ], [ 1387044.828526843106374, 5856618.849377661012113 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1101", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 932.0, "invlev_up": 929.5, "invlev_dn": 929.5, "manhole_up": "manhole_218_generated", "manhole_dn": "manhole_219_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387044.828526843106374, 5856618.849377661012113 ], [ 1387090.831838335609064, 5856638.43681376054883 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1102", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 949.9000244140625, "invlev_up": 929.5, "invlev_dn": 947.4000244140625, "manhole_up": "manhole_219_generated", "manhole_dn": "manhole_220_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387090.831838335609064, 5856638.43681376054883 ], [ 1387136.835149827878922, 5856658.024249859154224 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1103", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 949.9000244140625, "elevtn_dn": 924.4000244140625, "invlev_up": 947.4000244140625, "invlev_dn": 921.9000244140625, "manhole_up": "manhole_220_generated", "manhole_dn": "manhole_221_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387136.835149827878922, 5856658.024249859154224 ], [ 1387178.671980312326923, 5856685.128790453076363 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1104", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 924.4000244140625, "elevtn_dn": 924.4000244140625, "invlev_up": 921.9000244140625, "invlev_dn": 921.9000244140625, "manhole_up": "manhole_221_generated", "manhole_dn": "manhole_222_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387178.671980312326923, 5856685.128790453076363 ], [ 1387217.700535611249506, 5856716.320352808572352 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1105", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 924.4000244140625, "elevtn_dn": 940.0, "invlev_up": 921.9000244140625, "invlev_dn": 937.5, "manhole_up": "manhole_222_generated", "manhole_dn": "manhole_223_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387217.700535611249506, 5856716.320352808572352 ], [ 1387252.016686553368345, 5856752.649443434551358 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1106", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.0, "elevtn_dn": 940.0, "invlev_up": 937.5, "invlev_dn": 937.5, "manhole_up": "manhole_223_generated", "manhole_dn": "manhole_224_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387252.016686553368345, 5856752.649443434551358 ], [ 1387284.798919493798167, 5856790.190159549936652 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1107", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.0, "elevtn_dn": 894.29998779296875, "invlev_up": 937.5, "invlev_dn": 891.79998779296875, "manhole_up": "manhole_224_generated", "manhole_dn": "manhole_225_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387284.798919493798167, 5856790.190159549936652 ], [ 1387273.050185391213745, 5856831.931571422144771 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1108", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 894.29998779296875, "elevtn_dn": 891.5, "invlev_up": 891.79998779296875, "invlev_dn": 889.0, "manhole_up": "manhole_225_generated", "manhole_dn": "manhole_226_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387273.050185391213745, 5856831.931571422144771 ], [ 1387226.106990416301414, 5856849.145192969590425 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1109", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.5, "elevtn_dn": 891.5, "invlev_up": 889.0, "invlev_dn": 889.0, "manhole_up": "manhole_226_generated", "manhole_dn": "manhole_227_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387226.106990416301414, 5856849.145192969590425 ], [ 1387179.163795441389084, 5856866.358814516104758 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1110", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.5, "elevtn_dn": 881.0, "invlev_up": 889.0, "invlev_dn": 878.5, "manhole_up": "manhole_227_generated", "manhole_dn": "manhole_228_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387179.163795441389084, 5856866.358814516104758 ], [ 1387132.220600466709584, 5856883.572436063550413 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1111", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_228_generated", "manhole_dn": "manhole_229_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387132.220600466709584, 5856883.572436063550413 ], [ 1387091.513159692520276, 5856911.129930667579174 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1112", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_229_generated", "manhole_dn": "manhole_230_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387091.513159692520276, 5856911.129930667579174 ], [ 1387071.007118243258446, 5856956.15559543017298 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1113", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_230_generated", "manhole_dn": "manhole_231_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387071.007118243258446, 5856956.15559543017298 ], [ 1387043.749112035380676, 5856996.689189162105322 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1114", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 856.5, "invlev_up": 878.5, "invlev_dn": 854.0, "manhole_up": "manhole_231_generated", "manhole_dn": "manhole_232_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387043.749112035380676, 5856996.689189162105322 ], [ 1387004.639443967491388, 5857027.840532388538122 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1115", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_232_generated", "manhole_dn": "manhole_233_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387004.639443967491388, 5857027.840532388538122 ], [ 1386965.529775899834931, 5857058.991875615902245 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1116", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_233_generated", "manhole_dn": "manhole_234_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386965.529775899834931, 5857058.991875615902245 ], [ 1386926.702535050921142, 5857090.440239730291069 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1117", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_234_generated", "manhole_dn": "manhole_235_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386926.702535050921142, 5857090.440239730291069 ], [ 1386899.700979894958436, 5857131.871505072340369 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1118", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_235_generated", "manhole_dn": "manhole_236_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386899.700979894958436, 5857131.871505072340369 ], [ 1386903.6263940166682, 5857181.005935152061284 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1119", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 867.29998779296875, "invlev_up": 854.0, "invlev_dn": 864.79998779296875, "manhole_up": "manhole_236_generated", "manhole_dn": "manhole_237_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386903.6263940166682, 5857181.005935152061284 ], [ 1386920.841401966754347, 5857227.85734468139708 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1120", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 867.29998779296875, "elevtn_dn": 867.29998779296875, "invlev_up": 864.79998779296875, "invlev_dn": 864.79998779296875, "manhole_up": "manhole_237_generated", "manhole_dn": "manhole_238_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386920.841401966754347, 5857227.85734468139708 ], [ 1386940.647245415020734, 5857273.767048302106559 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1121", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 867.29998779296875, "elevtn_dn": 879.0, "invlev_up": 864.79998779296875, "invlev_dn": 876.5, "manhole_up": "manhole_238_generated", "manhole_dn": "manhole_239_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386940.647245415020734, 5857273.767048302106559 ], [ 1386960.453088863519952, 5857319.676751921884716 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1122", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 879.0, "elevtn_dn": 884.5, "invlev_up": 876.5, "invlev_dn": 882.0, "manhole_up": "manhole_239_generated", "manhole_dn": "manhole_240_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386960.453088863519952, 5857319.676751921884716 ], [ 1386980.258932311786339, 5857365.586455542594194 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1123", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 884.5, "invlev_up": 882.0, "invlev_dn": 882.0, "manhole_up": "manhole_240_generated", "manhole_dn": "manhole_241_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386980.258932311786339, 5857365.586455542594194 ], [ 1387000.064775760285556, 5857411.496159162372351 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1124", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 884.5, "invlev_up": 882.0, "invlev_dn": 882.0, "manhole_up": "manhole_241_generated", "manhole_dn": "manhole_242_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387000.064775760285556, 5857411.496159162372351 ], [ 1387007.528902114601806, 5857459.537025099620223 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1125", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 893.20001220703125, "invlev_up": 882.0, "invlev_dn": 890.70001220703125, "manhole_up": "manhole_242_generated", "manhole_dn": "manhole_243_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387007.528902114601806, 5857459.537025099620223 ], [ 1386963.21676475298591, 5857476.629049208015203 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1126", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 893.20001220703125, "elevtn_dn": 893.70001220703125, "invlev_up": 890.70001220703125, "invlev_dn": 891.20001220703125, "manhole_up": "manhole_243_generated", "manhole_dn": "manhole_244_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386963.21676475298591, 5857476.629049208015203 ], [ 1386913.783934087026864, 5857484.135433598421514 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1127", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 893.70001220703125, "elevtn_dn": 893.70001220703125, "invlev_up": 891.20001220703125, "invlev_dn": 891.20001220703125, "manhole_up": "manhole_244_generated", "manhole_dn": "manhole_245_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386913.783934087026864, 5857484.135433598421514 ], [ 1386870.539328352315351, 5857507.055611960589886 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1128", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 893.70001220703125, "elevtn_dn": 889.70001220703125, "invlev_up": 891.20001220703125, "invlev_dn": 887.20001220703125, "manhole_up": "manhole_245_generated", "manhole_dn": "manhole_246_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386870.539328352315351, 5857507.055611960589886 ], [ 1386832.820274166297168, 5857539.877026806585491 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1129", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.70001220703125, "elevtn_dn": 889.70001220703125, "invlev_up": 887.20001220703125, "invlev_dn": 887.20001220703125, "manhole_up": "manhole_246_generated", "manhole_dn": "manhole_247_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386832.820274166297168, 5857539.877026806585491 ], [ 1386795.101531907683238, 5857572.698800123296678 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1130", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.70001220703125, "elevtn_dn": 872.4000244140625, "invlev_up": 887.20001220703125, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_247_generated", "manhole_dn": "manhole_248_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386795.101531907683238, 5857572.698800123296678 ], [ 1386758.257366374600679, 5857606.496797049418092 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1131", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 872.4000244140625, "invlev_up": 869.9000244140625, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_248_generated", "manhole_dn": "manhole_249_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386758.257366374600679, 5857606.496797049418092 ], [ 1386721.502390186069533, 5857640.394349270500243 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1132", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 872.4000244140625, "invlev_up": 869.9000244140625, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_249_generated", "manhole_dn": "manhole_250_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386721.502390186069533, 5857640.394349270500243 ], [ 1386691.639095245627686, 5857680.292891399934888 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1133", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 860.70001220703125, "invlev_up": 869.9000244140625, "invlev_dn": 858.20001220703125, "manhole_up": "manhole_250_generated", "manhole_dn": "manhole_251_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386691.639095245627686, 5857680.292891399934888 ], [ 1386663.127201205352321, 5857721.366519738920033 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1134", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 860.70001220703125, "elevtn_dn": 864.10003662109375, "invlev_up": 858.20001220703125, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_251_generated", "manhole_dn": "manhole_252_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386663.127201205352321, 5857721.366519738920033 ], [ 1386634.70784462057054, 5857762.504245642572641 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1135", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 864.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_252_generated", "manhole_dn": "manhole_253_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386634.70784462057054, 5857762.504245642572641 ], [ 1386606.28848803602159, 5857803.64197154622525 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1136", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 864.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_253_generated", "manhole_dn": "manhole_254_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386606.28848803602159, 5857803.64197154622525 ], [ 1386577.851668093586341, 5857844.766917760483921 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1137", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 836.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 833.60003662109375, "manhole_up": "manhole_254_generated", "manhole_dn": "manhole_255_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386577.851668093586341, 5857844.766917760483921 ], [ 1386559.479123871540651, 5857890.340473555959761 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1138", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 836.10003662109375, "elevtn_dn": 836.10003662109375, "invlev_up": 833.60003662109375, "invlev_dn": 833.60003662109375, "manhole_up": "manhole_255_generated", "manhole_dn": "manhole_256_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386559.479123871540651, 5857890.340473555959761 ], [ 1386576.858566463226452, 5857935.633445805869997 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1139", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 836.10003662109375, "elevtn_dn": 854.9000244140625, "invlev_up": 833.60003662109375, "invlev_dn": 852.4000244140625, "manhole_up": "manhole_256_generated", "manhole_dn": "manhole_257_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386576.858566463226452, 5857935.633445805869997 ], [ 1386619.073707325849682, 5857961.189545376226306 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1140", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.9000244140625, "elevtn_dn": 854.9000244140625, "invlev_up": 852.4000244140625, "invlev_dn": 852.4000244140625, "manhole_up": "manhole_257_generated", "manhole_dn": "manhole_258_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386619.073707325849682, 5857961.189545376226306 ], [ 1386664.860782509436831, 5857981.27706332411617 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1141", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.9000244140625, "elevtn_dn": 871.60003662109375, "invlev_up": 852.4000244140625, "invlev_dn": 869.10003662109375, "manhole_up": "manhole_258_generated", "manhole_dn": "manhole_259_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386664.860782509436831, 5857981.27706332411617 ], [ 1386710.721602912992239, 5858001.195835201069713 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1142", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 871.60003662109375, "elevtn_dn": 865.10003662109375, "invlev_up": 869.10003662109375, "invlev_dn": 862.60003662109375, "manhole_up": "manhole_259_generated", "manhole_dn": "manhole_260_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386710.721602912992239, 5858001.195835201069713 ], [ 1386756.582423316547647, 5858021.114607078954577 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1143", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 865.10003662109375, "elevtn_dn": 864.70001220703125, "invlev_up": 862.60003662109375, "invlev_dn": 862.20001220703125, "manhole_up": "manhole_260_generated", "manhole_dn": "manhole_261_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386756.582423316547647, 5858021.114607078954577 ], [ 1386802.443243720103055, 5858041.033378956839442 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1144", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.70001220703125, "elevtn_dn": 864.70001220703125, "invlev_up": 862.20001220703125, "invlev_dn": 862.20001220703125, "manhole_up": "manhole_261_generated", "manhole_dn": "manhole_262_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386802.443243720103055, 5858041.033378956839442 ], [ 1386848.304064123658463, 5858060.952150834724307 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1145", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 864.70001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 862.20001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_262_generated", "manhole_dn": "manhole_263_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386848.304064123658463, 5858060.952150834724307 ], [ 1386892.843548113014549, 5858083.471454747952521 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1146", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_263_generated", "manhole_dn": "manhole_264_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386892.843548113014549, 5858083.471454747952521 ], [ 1386931.443847785238177, 5858115.251781782135367 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1147", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 853.60003662109375, "invlev_up": 856.70001220703125, "invlev_dn": 851.10003662109375, "manhole_up": "manhole_264_generated", "manhole_dn": "manhole_265_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386931.443847785238177, 5858115.251781782135367 ], [ 1386970.044147457228974, 5858147.032108817249537 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1148", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 853.60003662109375, "elevtn_dn": 853.60003662109375, "invlev_up": 851.10003662109375, "invlev_dn": 851.10003662109375, "manhole_up": "manhole_265_generated", "manhole_dn": "manhole_266_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386970.044147457228974, 5858147.032108817249537 ], [ 1387008.644447129452601, 5858178.812435851432383 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1149", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 853.60003662109375, "elevtn_dn": 842.4000244140625, "invlev_up": 851.10003662109375, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_266_generated", "manhole_dn": "manhole_267_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387008.644447129452601, 5858178.812435851432383 ], [ 1387047.244746801443398, 5858210.592762886546552 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1150", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 842.4000244140625, "invlev_up": 839.9000244140625, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_267_generated", "manhole_dn": "manhole_268_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387047.244746801443398, 5858210.592762886546552 ], [ 1387085.845046473667026, 5858242.373089920729399 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1151", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 842.4000244140625, "invlev_up": 839.9000244140625, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_268_generated", "manhole_dn": "manhole_269_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387085.845046473667026, 5858242.373089920729399 ], [ 1387124.445346145657822, 5858274.153416955843568 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1152", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 827.60003662109375, "invlev_up": 839.9000244140625, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_269_generated", "manhole_dn": "manhole_270_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387124.445346145657822, 5858274.153416955843568 ], [ 1387163.04564581788145, 5858305.933743990026414 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1153", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_270_generated", "manhole_dn": "manhole_271_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387163.04564581788145, 5858305.933743990026414 ], [ 1387201.829349192325026, 5858337.489215047098696 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1154", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 837.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 835.10003662109375, "manhole_up": "manhole_271_generated", "manhole_dn": "manhole_272_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387201.829349192325026, 5858337.489215047098696 ], [ 1387246.200623227981851, 5858359.687651782296598 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1155", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 837.60003662109375, "elevtn_dn": 837.60003662109375, "invlev_up": 835.10003662109375, "invlev_dn": 835.10003662109375, "manhole_up": "manhole_272_generated", "manhole_dn": "manhole_273_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387246.200623227981851, 5858359.687651782296598 ], [ 1387293.201938283629715, 5858376.741938757710159 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1156", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 837.60003662109375, "elevtn_dn": 843.79998779296875, "invlev_up": 835.10003662109375, "invlev_dn": 841.29998779296875, "manhole_up": "manhole_273_generated", "manhole_dn": "manhole_274_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387293.201938283629715, 5858376.741938757710159 ], [ 1387334.200528149493039, 5858401.732468435540795 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1157", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 843.79998779296875, "elevtn_dn": 822.60003662109375, "invlev_up": 841.29998779296875, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_274_generated", "manhole_dn": "manhole_275_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387334.200528149493039, 5858401.732468435540795 ], [ 1387307.843875054037198, 5858437.110805934295058 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1158", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 822.60003662109375, "invlev_up": 820.10003662109375, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_275_generated", "manhole_dn": "manhole_276_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387307.843875054037198, 5858437.110805934295058 ], [ 1387260.279569417703897, 5858425.045736069791019 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1159", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 820.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_276_generated", "manhole_dn": "manhole_277_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387260.279569417703897, 5858425.045736069791019 ], [ 1387211.448235018178821, 5858414.300554806366563 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1160", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_277_generated", "manhole_dn": "manhole_278_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387211.448235018178821, 5858414.300554806366563 ], [ 1387162.612191663123667, 5858403.576134512200952 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1161", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 822.29998779296875, "invlev_up": 825.10003662109375, "invlev_dn": 819.79998779296875, "manhole_up": "manhole_278_generated", "manhole_dn": "manhole_279_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387162.612191663123667, 5858403.576134512200952 ], [ 1387113.700150535441935, 5858393.210482948459685 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1162", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.29998779296875, "elevtn_dn": 822.29998779296875, "invlev_up": 819.79998779296875, "invlev_dn": 819.79998779296875, "manhole_up": "manhole_279_generated", "manhole_dn": "manhole_280_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387113.700150535441935, 5858393.210482948459685 ], [ 1387064.993171223672107, 5858381.975642333738506 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1163", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.29998779296875, "elevtn_dn": 827.79998779296875, "invlev_up": 819.79998779296875, "invlev_dn": 825.29998779296875, "manhole_up": "manhole_280_generated", "manhole_dn": "manhole_281_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387064.993171223672107, 5858381.975642333738506 ], [ 1387015.796386598376557, 5858376.342007979750633 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1164", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.79998779296875, "elevtn_dn": 827.79998779296875, "invlev_up": 825.29998779296875, "invlev_dn": 825.29998779296875, "manhole_up": "manhole_281_generated", "manhole_dn": "manhole_282_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387015.796386598376557, 5858376.342007979750633 ], [ 1386966.208506174152717, 5858382.746259398758411 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1165", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.79998779296875, "elevtn_dn": 833.9000244140625, "invlev_up": 825.29998779296875, "invlev_dn": 831.4000244140625, "manhole_up": "manhole_282_generated", "manhole_dn": "manhole_283_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386966.208506174152717, 5858382.746259398758411 ], [ 1386916.676812386140227, 5858389.559525708667934 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1166", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 833.9000244140625, "elevtn_dn": 833.9000244140625, "invlev_up": 831.4000244140625, "invlev_dn": 831.4000244140625, "manhole_up": "manhole_283_generated", "manhole_dn": "manhole_284_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386916.676812386140227, 5858389.559525708667934 ], [ 1386867.198860567295924, 5858396.764010772109032 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1167", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 833.9000244140625, "elevtn_dn": 833.20001220703125, "invlev_up": 831.4000244140625, "invlev_dn": 830.70001220703125, "manhole_up": "manhole_284_generated", "manhole_dn": "manhole_285_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386867.198860567295924, 5858396.764010772109032 ], [ 1386820.816385147860274, 5858411.854353901930153 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1168", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 833.20001220703125, "elevtn_dn": 809.60003662109375, "invlev_up": 830.70001220703125, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_285_generated", "manhole_dn": "manhole_286_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386820.816385147860274, 5858411.854353901930153 ], [ 1386841.361234750133008, 5858445.514383808709681 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1169", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 809.79998779296875, "invlev_up": 807.10003662109375, "invlev_dn": 807.29998779296875, "manhole_up": "manhole_286_generated", "manhole_dn": "manhole_287_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386841.361234750133008, 5858445.514383808709681 ], [ 1386890.796275103231892, 5858452.915634987875819 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1170", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.79998779296875, "elevtn_dn": 809.79998779296875, "invlev_up": 807.29998779296875, "invlev_dn": 807.29998779296875, "manhole_up": "manhole_287_generated", "manhole_dn": "manhole_288_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386890.796275103231892, 5858452.915634987875819 ], [ 1386940.277140651131049, 5858460.100081093609333 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1171", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.79998779296875, "elevtn_dn": 805.4000244140625, "invlev_up": 807.29998779296875, "invlev_dn": 802.9000244140625, "manhole_up": "manhole_288_generated", "manhole_dn": "manhole_289_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386940.277140651131049, 5858460.100081093609333 ], [ 1386989.847997799050063, 5858466.483407464809716 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1172", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.4000244140625, "elevtn_dn": 805.4000244140625, "invlev_up": 802.9000244140625, "invlev_dn": 802.9000244140625, "manhole_up": "manhole_289_generated", "manhole_dn": "manhole_290_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386989.847997799050063, 5858466.483407464809716 ], [ 1387039.689648573985323, 5858470.45608530472964 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1173", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.4000244140625, "elevtn_dn": 804.60003662109375, "invlev_up": 802.9000244140625, "invlev_dn": 802.10003662109375, "manhole_up": "manhole_290_generated", "manhole_dn": "manhole_291_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387039.689648573985323, 5858470.45608530472964 ], [ 1387088.843806148739532, 5858479.424946941435337 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1174", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.60003662109375, "elevtn_dn": 809.9000244140625, "invlev_up": 802.10003662109375, "invlev_dn": 807.4000244140625, "manhole_up": "manhole_291_generated", "manhole_dn": "manhole_292_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387088.843806148739532, 5858479.424946941435337 ], [ 1387137.90604472765699, 5858489.061806742101908 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1175", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.9000244140625, "elevtn_dn": 809.9000244140625, "invlev_up": 807.4000244140625, "invlev_dn": 807.4000244140625, "manhole_up": "manhole_292_generated", "manhole_dn": "manhole_293_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387137.90604472765699, 5858489.061806742101908 ], [ 1387186.336529975291342, 5858500.87968063633889 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1176", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.9000244140625, "elevtn_dn": 822.60003662109375, "invlev_up": 807.4000244140625, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_293_generated", "manhole_dn": "manhole_294_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387186.336529975291342, 5858500.87968063633889 ], [ 1387231.661050535272807, 5858521.423059928230941 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1177", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 787.70001220703125, "invlev_up": 820.10003662109375, "invlev_dn": 785.20001220703125, "manhole_up": "manhole_294_generated", "manhole_dn": "manhole_295_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387231.661050535272807, 5858521.423059928230941 ], [ 1387268.120024613803253, 5858555.03504909388721 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1178", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.70001220703125, "elevtn_dn": 787.70001220703125, "invlev_up": 785.20001220703125, "invlev_dn": 785.20001220703125, "manhole_up": "manhole_295_generated", "manhole_dn": "manhole_296_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387268.120024613803253, 5858555.03504909388721 ], [ 1387300.917169471969828, 5858592.775208213366568 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1179", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.70001220703125, "elevtn_dn": 797.10003662109375, "invlev_up": 785.20001220703125, "invlev_dn": 794.60003662109375, "manhole_up": "manhole_296_generated", "manhole_dn": "manhole_297_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387300.917169471969828, 5858592.775208213366568 ], [ 1387340.521646688459441, 5858622.315198052674532 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1180", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 797.10003662109375, "elevtn_dn": 797.10003662109375, "invlev_up": 794.60003662109375, "invlev_dn": 794.60003662109375, "manhole_up": "manhole_297_generated", "manhole_dn": "manhole_298_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387340.521646688459441, 5858622.315198052674532 ], [ 1387387.476920192595571, 5858639.495844470337033 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1181", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 797.10003662109375, "elevtn_dn": 806.10003662109375, "invlev_up": 794.60003662109375, "invlev_dn": 803.60003662109375, "manhole_up": "manhole_298_generated", "manhole_dn": "manhole_299_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387387.476920192595571, 5858639.495844470337033 ], [ 1387436.116963447071612, 5858650.82861250359565 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1182", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.10003662109375, "elevtn_dn": 806.10003662109375, "invlev_up": 803.60003662109375, "invlev_dn": 803.60003662109375, "manhole_up": "manhole_299_generated", "manhole_dn": "manhole_300_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387436.116963447071612, 5858650.82861250359565 ], [ 1387485.194103535497561, 5858660.261457678861916 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1183", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.10003662109375, "elevtn_dn": 807.70001220703125, "invlev_up": 803.60003662109375, "invlev_dn": 805.20001220703125, "manhole_up": "manhole_300_generated", "manhole_dn": "manhole_301_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387485.194103535497561, 5858660.261457678861916 ], [ 1387533.804190448950976, 5858671.493853995576501 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1184", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.70001220703125, "elevtn_dn": 772.20001220703125, "invlev_up": 805.20001220703125, "invlev_dn": 769.70001220703125, "manhole_up": "manhole_301_generated", "manhole_dn": "manhole_302_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387533.804190448950976, 5858671.493853995576501 ], [ 1387580.2968336828053, 5858689.619015210308135 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1185", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.20001220703125, "elevtn_dn": 778.79998779296875, "invlev_up": 769.70001220703125, "invlev_dn": 776.29998779296875, "manhole_up": "manhole_302_generated", "manhole_dn": "manhole_303_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387580.2968336828053, 5858689.619015210308135 ], [ 1387628.455277157016098, 5858703.062848121859133 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1186", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.79998779296875, "elevtn_dn": 778.79998779296875, "invlev_up": 776.29998779296875, "invlev_dn": 776.29998779296875, "manhole_up": "manhole_303_generated", "manhole_dn": "manhole_304_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387628.455277157016098, 5858703.062848121859133 ], [ 1387677.211432087467983, 5858713.7862489502877 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1187", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.79998779296875, "elevtn_dn": 786.70001220703125, "invlev_up": 776.29998779296875, "invlev_dn": 784.20001220703125, "manhole_up": "manhole_304_generated", "manhole_dn": "manhole_305_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387677.211432087467983, 5858713.7862489502877 ], [ 1387726.995392211945727, 5858712.747126803733408 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1188", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.70001220703125, "elevtn_dn": 786.70001220703125, "invlev_up": 784.20001220703125, "invlev_dn": 784.20001220703125, "manhole_up": "manhole_305_generated", "manhole_dn": "manhole_306_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387726.995392211945727, 5858712.747126803733408 ], [ 1387773.343349169706926, 5858725.014477553777397 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1189", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.70001220703125, "elevtn_dn": 797.70001220703125, "invlev_up": 784.20001220703125, "invlev_dn": 795.20001220703125, "manhole_up": "manhole_306_generated", "manhole_dn": "manhole_307_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387773.343349169706926, 5858725.014477553777397 ], [ 1387806.363672176143155, 5858762.310494473204017 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1190", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 797.70001220703125, "elevtn_dn": 797.70001220703125, "invlev_up": 795.20001220703125, "invlev_dn": 795.20001220703125, "manhole_up": "manhole_307_generated", "manhole_dn": "manhole_308_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387806.363672176143155, 5858762.310494473204017 ], [ 1387799.717027904232964, 5858810.149600365199149 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1191", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 797.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 795.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_308_generated", "manhole_dn": "manhole_309_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387799.717027904232964, 5858810.149600365199149 ], [ 1387771.971139753237367, 5858850.86109375115484 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1192", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_309_generated", "manhole_dn": "manhole_310_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387771.971139753237367, 5858850.86109375115484 ], [ 1387723.07675126590766, 5858854.679317841306329 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1193", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_310_generated", "manhole_dn": "manhole_311_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387723.07675126590766, 5858854.679317841306329 ], [ 1387673.274138238513842, 5858850.996178055182099 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1194", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_311_generated", "manhole_dn": "manhole_312_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387673.274138238513842, 5858850.996178055182099 ], [ 1387624.170362570788711, 5858858.384703231044114 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1195", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_312_generated", "manhole_dn": "manhole_313_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387624.170362570788711, 5858858.384703231044114 ], [ 1387575.715393897145987, 5858857.046076283790171 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1196", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_313_generated", "manhole_dn": "manhole_314_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387575.715393897145987, 5858857.046076283790171 ], [ 1387529.438332577701658, 5858838.116818149574101 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1197", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_314_generated", "manhole_dn": "manhole_315_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387529.438332577701658, 5858838.116818149574101 ], [ 1387481.179235466290265, 5858825.222027675248682 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1198", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_315_generated", "manhole_dn": "manhole_316_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387481.179235466290265, 5858825.222027675248682 ], [ 1387432.215501294471323, 5858815.797906777821481 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1199", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 772.79998779296875, "invlev_up": 774.70001220703125, "invlev_dn": 770.29998779296875, "manhole_up": "manhole_316_generated", "manhole_dn": "manhole_317_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387432.215501294471323, 5858815.797906777821481 ], [ 1387382.431881646160036, 5858811.154251328669488 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1200", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.79998779296875, "elevtn_dn": 747.10003662109375, "invlev_up": 770.29998779296875, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_317_generated", "manhole_dn": "manhole_318_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387382.431881646160036, 5858811.154251328669488 ], [ 1387336.607072548242286, 5858824.075685098767281 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1201", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 747.10003662109375, "invlev_up": 744.60003662109375, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_318_generated", "manhole_dn": "manhole_319_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387336.607072548242286, 5858824.075685098767281 ], [ 1387327.458137275883928, 5858870.88596049696207 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1202", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 747.10003662109375, "invlev_up": 744.60003662109375, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_319_generated", "manhole_dn": "manhole_320_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387327.458137275883928, 5858870.88596049696207 ], [ 1387344.619252334116027, 5858917.848375800997019 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1203", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 773.70001220703125, "invlev_up": 744.60003662109375, "invlev_dn": 771.20001220703125, "manhole_up": "manhole_320_generated", "manhole_dn": "manhole_321_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387344.619252334116027, 5858917.848375800997019 ], [ 1387358.089983508689329, 5858965.710649829357862 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1204", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 773.70001220703125, "elevtn_dn": 773.70001220703125, "invlev_up": 771.20001220703125, "invlev_dn": 771.20001220703125, "manhole_up": "manhole_321_generated", "manhole_dn": "manhole_322_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387358.089983508689329, 5858965.710649829357862 ], [ 1387329.564612702699378, 5859003.583583393134177 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1205", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 773.70001220703125, "elevtn_dn": 774.29998779296875, "invlev_up": 771.20001220703125, "invlev_dn": 771.79998779296875, "manhole_up": "manhole_322_generated", "manhole_dn": "manhole_323_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387329.564612702699378, 5859003.583583393134177 ], [ 1387285.783744251355529, 5858993.703191691078246 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1206", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.29998779296875, "elevtn_dn": 774.29998779296875, "invlev_up": 771.79998779296875, "invlev_dn": 771.79998779296875, "manhole_up": "manhole_323_generated", "manhole_dn": "manhole_324_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387285.783744251355529, 5858993.703191691078246 ], [ 1387248.355973182013258, 5858961.31797497626394 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1207", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.29998779296875, "elevtn_dn": 769.4000244140625, "invlev_up": 771.79998779296875, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_324_generated", "manhole_dn": "manhole_325_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387248.355973182013258, 5858961.31797497626394 ], [ 1387199.500433639157563, 5858963.645901591517031 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1208", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 769.4000244140625, "invlev_up": 766.9000244140625, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_325_generated", "manhole_dn": "manhole_326_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387199.500433639157563, 5858963.645901591517031 ], [ 1387151.482699199579656, 5858977.583961015567183 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1209", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 762.60003662109375, "invlev_up": 766.9000244140625, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_326_generated", "manhole_dn": "manhole_327_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387151.482699199579656, 5858977.583961015567183 ], [ 1387103.632611613254994, 5858992.082134889438748 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1210", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 762.60003662109375, "invlev_up": 760.10003662109375, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_327_generated", "manhole_dn": "manhole_328_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387103.632611613254994, 5858992.082134889438748 ], [ 1387055.853339510038495, 5859006.816905959509313 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1211", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 755.79998779296875, "invlev_up": 760.10003662109375, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_328_generated", "manhole_dn": "manhole_329_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387055.853339510038495, 5859006.816905959509313 ], [ 1387008.074067406589165, 5859021.551677029579878 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1212", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_329_generated", "manhole_dn": "manhole_330_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387008.074067406589165, 5859021.551677029579878 ], [ 1386960.294795303372666, 5859036.286448099650443 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1213", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 749.5, "invlev_up": 753.29998779296875, "invlev_dn": 747.0, "manhole_up": "manhole_330_generated", "manhole_dn": "manhole_331_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386960.294795303372666, 5859036.286448099650443 ], [ 1386912.515523200156167, 5859051.021219169721007 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1214", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 749.5, "elevtn_dn": 749.5, "invlev_up": 747.0, "invlev_dn": 747.0, "manhole_up": "manhole_331_generated", "manhole_dn": "manhole_332_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386912.515523200156167, 5859051.021219169721007 ], [ 1386864.736251096706837, 5859065.755990239791572 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1215", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 749.5, "elevtn_dn": 727.10003662109375, "invlev_up": 747.0, "invlev_dn": 724.60003662109375, "manhole_up": "manhole_332_generated", "manhole_dn": "manhole_333_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386864.736251096706837, 5859065.755990239791572 ], [ 1386816.956978993490338, 5859080.490761309862137 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1216", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.10003662109375, "elevtn_dn": 752.29998779296875, "invlev_up": 724.60003662109375, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_333_generated", "manhole_dn": "manhole_334_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386816.956978993490338, 5859080.490761309862137 ], [ 1386769.832018451532349, 5859096.976014334708452 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1217", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 738.0, "invlev_up": 749.79998779296875, "invlev_dn": 735.5, "manhole_up": "manhole_334_generated", "manhole_dn": "manhole_335_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386769.832018451532349, 5859096.976014334708452 ], [ 1386724.102282747160643, 5859117.193917133845389 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1218", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 738.0, "invlev_up": 735.5, "invlev_dn": 735.5, "manhole_up": "manhole_335_generated", "manhole_dn": "manhole_336_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386724.102282747160643, 5859117.193917133845389 ], [ 1386678.372547042788938, 5859137.411819933913648 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1219", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 732.79998779296875, "invlev_up": 735.5, "invlev_dn": 730.29998779296875, "manhole_up": "manhole_336_generated", "manhole_dn": "manhole_337_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386678.372547042788938, 5859137.411819933913648 ], [ 1386632.642811338417232, 5859157.629722733050585 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1220", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.79998779296875, "elevtn_dn": 732.79998779296875, "invlev_up": 730.29998779296875, "invlev_dn": 730.29998779296875, "manhole_up": "manhole_337_generated", "manhole_dn": "manhole_338_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386632.642811338417232, 5859157.629722733050585 ], [ 1386586.913075634045526, 5859177.847625533118844 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1221", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.79998779296875, "elevtn_dn": 732.60003662109375, "invlev_up": 730.29998779296875, "invlev_dn": 730.10003662109375, "manhole_up": "manhole_338_generated", "manhole_dn": "manhole_339_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386586.913075634045526, 5859177.847625533118844 ], [ 1386541.181931287748739, 5859198.062337793409824 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1222", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.60003662109375, "elevtn_dn": 732.60003662109375, "invlev_up": 730.10003662109375, "invlev_dn": 730.10003662109375, "manhole_up": "manhole_339_generated", "manhole_dn": "manhole_340_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386541.181931287748739, 5859198.062337793409824 ], [ 1386495.431538854492828, 5859218.233453613705933 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1223", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.60003662109375, "elevtn_dn": 742.5, "invlev_up": 730.10003662109375, "invlev_dn": 740.0, "manhole_up": "manhole_340_generated", "manhole_dn": "manhole_341_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386495.431538854492828, 5859218.233453613705933 ], [ 1386449.681146421469748, 5859238.404569433070719 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1224", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 742.5, "invlev_up": 740.0, "invlev_dn": 740.0, "manhole_up": "manhole_341_generated", "manhole_dn": "manhole_342_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386449.681146421469748, 5859238.404569433070719 ], [ 1386404.749107032548636, 5859260.314221715554595 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1225", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 717.60003662109375, "invlev_up": 740.0, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_342_generated", "manhole_dn": "manhole_343_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386404.749107032548636, 5859260.314221715554595 ], [ 1386360.756595908896998, 5859284.020064728334546 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1226", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 717.60003662109375, "invlev_up": 715.10003662109375, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_343_generated", "manhole_dn": "manhole_344_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386360.756595908896998, 5859284.020064728334546 ], [ 1386317.622744857333601, 5859309.307279178872705 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1227", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 711.0, "invlev_up": 715.10003662109375, "invlev_dn": 708.5, "manhole_up": "manhole_344_generated", "manhole_dn": "manhole_345_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386317.622744857333601, 5859309.307279178872705 ], [ 1386274.488893805770203, 5859334.594493629410863 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1228", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 711.0, "elevtn_dn": 717.60003662109375, "invlev_up": 708.5, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_345_generated", "manhole_dn": "manhole_346_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386274.488893805770203, 5859334.594493629410863 ], [ 1386231.354723542230204, 5859359.881163572892547 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1229", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 739.0, "invlev_up": 715.10003662109375, "invlev_dn": 736.5, "manhole_up": "manhole_346_generated", "manhole_dn": "manhole_347_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386231.354723542230204, 5859359.881163572892547 ], [ 1386188.788941488368437, 5859385.978958465158939 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1230", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 739.0, "invlev_up": 736.5, "invlev_dn": 736.5, "manhole_up": "manhole_347_generated", "manhole_dn": "manhole_348_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386188.788941488368437, 5859385.978958465158939 ], [ 1386153.170269979629666, 5859420.751348914578557 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1231", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 739.0, "invlev_up": 736.5, "invlev_dn": 736.5, "manhole_up": "manhole_348_generated", "manhole_dn": "manhole_349_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386153.170269979629666, 5859420.751348914578557 ], [ 1386127.241226618411019, 5859463.08446778729558 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1232", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 770.60003662109375, "invlev_up": 736.5, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_349_generated", "manhole_dn": "manhole_350_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386127.241226618411019, 5859463.08446778729558 ], [ 1386108.996456971857697, 5859509.052053713239729 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1233", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_350_generated", "manhole_dn": "manhole_351_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386108.996456971857697, 5859509.052053713239729 ], [ 1386105.954033384332433, 5859558.959127158857882 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1234", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_351_generated", "manhole_dn": "manhole_352_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386105.954033384332433, 5859558.959127158857882 ], [ 1386101.917093347059563, 5859608.782215913757682 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1235", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 779.79998779296875, "invlev_up": 768.10003662109375, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_352_generated", "manhole_dn": "manhole_353_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386101.917093347059563, 5859608.782215913757682 ], [ 1386088.458339030388743, 5859656.652665913105011 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1236", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 779.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_353_generated", "manhole_dn": "manhole_354_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386088.458339030388743, 5859656.652665913105011 ], [ 1386075.652030121767893, 5859704.419184413738549 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1237", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 779.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_354_generated", "manhole_dn": "manhole_355_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386075.652030121767893, 5859704.419184413738549 ], [ 1386076.574770522769541, 5859754.410392354242504 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1238", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_355_generated", "manhole_dn": "manhole_356_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386076.574770522769541, 5859754.410392354242504 ], [ 1386077.497510923538357, 5859804.401600294746459 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_9_E1239", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_9", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_356_generated", "manhole_dn": "manhole_357_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386077.497510923538357, 5859804.401600294746459 ], [ 1386078.420251324307173, 5859854.392808235250413 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E195", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 814.29998779296875, "elevtn_dn": 802.9000244140625, "invlev_up": 811.79998779296875, "invlev_dn": 800.4000244140625, "manhole_up": "manhole_358_generated", "manhole_dn": "manhole_359_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384050.267680946970358, 5856698.702001548372209 ], [ 1384085.778961833100766, 5856733.441067186184227 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E196", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.9000244140625, "elevtn_dn": 802.9000244140625, "invlev_up": 800.4000244140625, "invlev_dn": 800.4000244140625, "manhole_up": "manhole_359_generated", "manhole_dn": "manhole_360_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384085.778961833100766, 5856733.441067186184227 ], [ 1384122.993944165529683, 5856766.592179889790714 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E197", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.9000244140625, "elevtn_dn": 816.29998779296875, "invlev_up": 800.4000244140625, "invlev_dn": 813.79998779296875, "manhole_up": "manhole_360_generated", "manhole_dn": "manhole_361_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384122.993944165529683, 5856766.592179889790714 ], [ 1384160.350959801580757, 5856799.578122235834599 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E198", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.29998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 813.79998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_361_generated", "manhole_dn": "manhole_362_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384160.350959801580757, 5856799.578122235834599 ], [ 1384198.384374253917485, 5856831.724873264320195 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E199", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 798.29998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_362_generated", "manhole_dn": "manhole_363_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384198.384374253917485, 5856831.724873264320195 ], [ 1384230.112839305773377, 5856870.159957353956997 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E200", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 793.9000244140625, "invlev_up": 798.29998779296875, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_363_generated", "manhole_dn": "manhole_364_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384230.112839305773377, 5856870.159957353956997 ], [ 1384259.121702386764809, 5856910.628996902145445 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E201", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 807.60003662109375, "invlev_up": 791.4000244140625, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_364_generated", "manhole_dn": "manhole_365_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384259.121702386764809, 5856910.628996902145445 ], [ 1384287.023718592710793, 5856951.925833041779697 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E202", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_365_generated", "manhole_dn": "manhole_366_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384287.023718592710793, 5856951.925833041779697 ], [ 1384314.929269487503916, 5856993.22028074786067 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E203", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_366_generated", "manhole_dn": "manhole_367_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384314.929269487503916, 5856993.22028074786067 ], [ 1384344.819752591196448, 5857033.056208833120763 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E204", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_367_generated", "manhole_dn": "manhole_368_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384344.819752591196448, 5857033.056208833120763 ], [ 1384375.891110281459987, 5857072.024425559677184 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E205", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_368_generated", "manhole_dn": "manhole_369_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384375.891110281459987, 5857072.024425559677184 ], [ 1384412.732155854580924, 5857105.507668288424611 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E206", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_369_generated", "manhole_dn": "manhole_370_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384412.732155854580924, 5857105.507668288424611 ], [ 1384450.07948348694481, 5857138.509612204506993 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E207", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_370_generated", "manhole_dn": "manhole_371_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384450.07948348694481, 5857138.509612204506993 ], [ 1384487.42686335532926, 5857171.511497005820274 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E208", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 805.0, "invlev_up": 793.4000244140625, "invlev_dn": 802.5, "manhole_up": "manhole_371_generated", "manhole_dn": "manhole_372_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384487.42686335532926, 5857171.511497005820274 ], [ 1384525.207759798038751, 5857204.014277670532465 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E209", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 796.29998779296875, "invlev_up": 802.5, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_372_generated", "manhole_dn": "manhole_373_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384525.207759798038751, 5857204.014277670532465 ], [ 1384563.111988977529109, 5857236.375065575353801 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E210", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 796.29998779296875, "invlev_up": 793.79998779296875, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_373_generated", "manhole_dn": "manhole_374_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384563.111988977529109, 5857236.375065575353801 ], [ 1384601.016218156786636, 5857268.735853480175138 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E211", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 786.10003662109375, "invlev_up": 793.79998779296875, "invlev_dn": 783.60003662109375, "manhole_up": "manhole_374_generated", "manhole_dn": "manhole_375_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384601.016218156786636, 5857268.735853480175138 ], [ 1384638.920447336044163, 5857301.096641384996474 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E212", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.10003662109375, "elevtn_dn": 794.29998779296875, "invlev_up": 783.60003662109375, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_375_generated", "manhole_dn": "manhole_376_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384638.920447336044163, 5857301.096641384996474 ], [ 1384669.604954990325496, 5857340.313404724933207 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E213", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 794.29998779296875, "invlev_up": 791.79998779296875, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_376_generated", "manhole_dn": "manhole_377_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384669.604954990325496, 5857340.313404724933207 ], [ 1384699.518247769214213, 5857380.104403200559318 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E214", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 794.29998779296875, "invlev_up": 791.79998779296875, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_377_generated", "manhole_dn": "manhole_378_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384699.518247769214213, 5857380.104403200559318 ], [ 1384719.806332413339987, 5857425.627417215146124 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E215", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 782.0, "invlev_up": 791.79998779296875, "invlev_dn": 779.5, "manhole_up": "manhole_378_generated", "manhole_dn": "manhole_379_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384719.806332413339987, 5857425.627417215146124 ], [ 1384740.094417057465762, 5857471.150431229732931 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E216", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 782.0, "elevtn_dn": 789.70001220703125, "invlev_up": 779.5, "invlev_dn": 787.20001220703125, "manhole_up": "manhole_379_generated", "manhole_dn": "manhole_380_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384740.094417057465762, 5857471.150431229732931 ], [ 1384760.382501701591536, 5857516.673445244319737 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E217", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 789.70001220703125, "elevtn_dn": 789.70001220703125, "invlev_up": 787.20001220703125, "invlev_dn": 787.20001220703125, "manhole_up": "manhole_380_generated", "manhole_dn": "manhole_381_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384760.382501701591536, 5857516.673445244319737 ], [ 1384780.670586345717311, 5857562.196459258906543 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E218", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 789.70001220703125, "elevtn_dn": 796.5, "invlev_up": 787.20001220703125, "invlev_dn": 794.0, "manhole_up": "manhole_381_generated", "manhole_dn": "manhole_382_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384780.670586345717311, 5857562.196459258906543 ], [ 1384802.672203443944454, 5857606.838341221213341 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E219", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.5, "elevtn_dn": 771.9000244140625, "invlev_up": 794.0, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_382_generated", "manhole_dn": "manhole_383_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384802.672203443944454, 5857606.838341221213341 ], [ 1384827.896526007680222, 5857649.823044718243182 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E220", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_383_generated", "manhole_dn": "manhole_384_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384827.896526007680222, 5857649.823044718243182 ], [ 1384854.757882944308221, 5857691.606820800341666 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E221", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_384_generated", "manhole_dn": "manhole_385_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384854.757882944308221, 5857691.606820800341666 ], [ 1384888.185768931638449, 5857728.573395187035203 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E222", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_385_generated", "manhole_dn": "manhole_386_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384888.185768931638449, 5857728.573395187035203 ], [ 1384921.613654918735847, 5857765.539969574660063 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E223", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 755.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_386_generated", "manhole_dn": "manhole_387_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384921.613654918735847, 5857765.539969574660063 ], [ 1384956.145453942706808, 5857801.445756647735834 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E224", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 755.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_387_generated", "manhole_dn": "manhole_388_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384956.145453942706808, 5857801.445756647735834 ], [ 1384991.751306539867073, 5857836.319449373520911 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E225", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 746.0, "invlev_up": 755.4000244140625, "invlev_dn": 743.5, "manhole_up": "manhole_388_generated", "manhole_dn": "manhole_389_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384991.751306539867073, 5857836.319449373520911 ], [ 1385027.357159137027338, 5857871.193142099305987 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E226", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 746.0, "elevtn_dn": 755.79998779296875, "invlev_up": 743.5, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_389_generated", "manhole_dn": "manhole_390_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385027.357159137027338, 5857871.193142099305987 ], [ 1385062.963011734187603, 5857906.066834825091064 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E227", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 728.60003662109375, "invlev_up": 753.29998779296875, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_390_generated", "manhole_dn": "manhole_391_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385062.963011734187603, 5857906.066834825091064 ], [ 1385098.568864331347868, 5857940.940527551807463 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E228", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 728.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_391_generated", "manhole_dn": "manhole_392_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385098.568864331347868, 5857940.940527551807463 ], [ 1385135.753846400883049, 5857974.029479116201401 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E229", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 728.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_392_generated", "manhole_dn": "manhole_393_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385135.753846400883049, 5857974.029479116201401 ], [ 1385175.738456205930561, 5858003.622975903563201 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E230", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 735.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 733.10003662109375, "manhole_up": "manhole_393_generated", "manhole_dn": "manhole_394_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385175.738456205930561, 5858003.622975903563201 ], [ 1385218.653756857383996, 5858028.965196672827005 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E231", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 735.60003662109375, "elevtn_dn": 735.60003662109375, "invlev_up": 733.10003662109375, "invlev_dn": 733.10003662109375, "manhole_up": "manhole_394_generated", "manhole_dn": "manhole_395_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385218.653756857383996, 5858028.965196672827005 ], [ 1385262.454936756985262, 5858052.706982978619635 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E232", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 735.60003662109375, "elevtn_dn": 742.0, "invlev_up": 733.10003662109375, "invlev_dn": 739.5, "manhole_up": "manhole_395_generated", "manhole_dn": "manhole_396_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385262.454936756985262, 5858052.706982978619635 ], [ 1385306.715555034345016, 5858075.618745312094688 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E233", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.0, "elevtn_dn": 742.0, "invlev_up": 739.5, "invlev_dn": 739.5, "manhole_up": "manhole_396_generated", "manhole_dn": "manhole_397_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385306.715555034345016, 5858075.618745312094688 ], [ 1385350.97617331170477, 5858098.530507644638419 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E234", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.0, "elevtn_dn": 736.0, "invlev_up": 739.5, "invlev_dn": 733.5, "manhole_up": "manhole_397_generated", "manhole_dn": "manhole_398_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385350.97617331170477, 5858098.530507644638419 ], [ 1385395.236791589297354, 5858121.442269978113472 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E235", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 736.0, "elevtn_dn": 736.0, "invlev_up": 733.5, "invlev_dn": 733.5, "manhole_up": "manhole_398_generated", "manhole_dn": "manhole_399_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385395.236791589297354, 5858121.442269978113472 ], [ 1385439.497409866657108, 5858144.354032310657203 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E236", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 736.0, "elevtn_dn": 737.9000244140625, "invlev_up": 733.5, "invlev_dn": 735.4000244140625, "manhole_up": "manhole_399_generated", "manhole_dn": "manhole_400_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385439.497409866657108, 5858144.354032310657203 ], [ 1385483.758028144016862, 5858167.265794644132257 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E237", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.9000244140625, "elevtn_dn": 737.9000244140625, "invlev_up": 735.4000244140625, "invlev_dn": 735.4000244140625, "manhole_up": "manhole_400_generated", "manhole_dn": "manhole_401_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385483.758028144016862, 5858167.265794644132257 ], [ 1385528.018646421376616, 5858190.17755697760731 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E238", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.9000244140625, "elevtn_dn": 727.29998779296875, "invlev_up": 735.4000244140625, "invlev_dn": 724.79998779296875, "manhole_up": "manhole_401_generated", "manhole_dn": "manhole_402_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385528.018646421376616, 5858190.17755697760731 ], [ 1385571.606102279853076, 5858214.277655217796564 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E239", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.29998779296875, "elevtn_dn": 727.29998779296875, "invlev_up": 724.79998779296875, "invlev_dn": 724.79998779296875, "manhole_up": "manhole_402_generated", "manhole_dn": "manhole_403_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385571.606102279853076, 5858214.277655217796564 ], [ 1385614.013400863157585, 5858240.461089110001922 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E240", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.29998779296875, "elevtn_dn": 690.60003662109375, "invlev_up": 724.79998779296875, "invlev_dn": 688.10003662109375, "manhole_up": "manhole_403_generated", "manhole_dn": "manhole_404_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385614.013400863157585, 5858240.461089110001922 ], [ 1385656.420699446462095, 5858266.644523002207279 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E241", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 690.60003662109375, "elevtn_dn": 733.60003662109375, "invlev_up": 688.10003662109375, "invlev_dn": 731.10003662109375, "manhole_up": "manhole_404_generated", "manhole_dn": "manhole_405_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385656.420699446462095, 5858266.644523002207279 ], [ 1385698.773111530812457, 5858292.8961898451671 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E242", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 733.60003662109375, "elevtn_dn": 733.60003662109375, "invlev_up": 731.10003662109375, "invlev_dn": 731.10003662109375, "manhole_up": "manhole_405_generated", "manhole_dn": "manhole_406_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385698.773111530812457, 5858292.8961898451671 ], [ 1385733.435650466475636, 5858328.707634637132287 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E243", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 733.60003662109375, "elevtn_dn": 721.60003662109375, "invlev_up": 731.10003662109375, "invlev_dn": 719.10003662109375, "manhole_up": "manhole_406_generated", "manhole_dn": "manhole_407_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385733.435650466475636, 5858328.707634637132287 ], [ 1385768.098189401905984, 5858364.519079428166151 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E244", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 721.60003662109375, "elevtn_dn": 721.60003662109375, "invlev_up": 719.10003662109375, "invlev_dn": 719.10003662109375, "manhole_up": "manhole_407_generated", "manhole_dn": "manhole_408_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385768.098189401905984, 5858364.519079428166151 ], [ 1385795.882535298354924, 5858405.467093757353723 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E245", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 721.60003662109375, "elevtn_dn": 739.0, "invlev_up": 719.10003662109375, "invlev_dn": 736.5, "manhole_up": "manhole_408_generated", "manhole_dn": "manhole_409_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385795.882535298354924, 5858405.467093757353723 ], [ 1385820.377634756267071, 5858448.871486231684685 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E246", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 727.79998779296875, "invlev_up": 736.5, "invlev_dn": 725.29998779296875, "manhole_up": "manhole_409_generated", "manhole_dn": "manhole_410_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385820.377634756267071, 5858448.871486231684685 ], [ 1385841.084314390551299, 5858493.920932004228234 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E247", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.79998779296875, "elevtn_dn": 727.79998779296875, "invlev_up": 725.29998779296875, "invlev_dn": 725.29998779296875, "manhole_up": "manhole_410_generated", "manhole_dn": "manhole_411_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385841.084314390551299, 5858493.920932004228234 ], [ 1385856.076261736918241, 5858541.451897682622075 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E248", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 727.79998779296875, "elevtn_dn": 734.9000244140625, "invlev_up": 725.29998779296875, "invlev_dn": 732.4000244140625, "manhole_up": "manhole_411_generated", "manhole_dn": "manhole_412_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385856.076261736918241, 5858541.451897682622075 ], [ 1385865.668899663724005, 5858590.250006795860827 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E249", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 734.9000244140625, "elevtn_dn": 734.9000244140625, "invlev_up": 732.4000244140625, "invlev_dn": 732.4000244140625, "manhole_up": "manhole_412_generated", "manhole_dn": "manhole_413_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385865.668899663724005, 5858590.250006795860827 ], [ 1385873.387286560609937, 5858639.487976770848036 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E250", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 734.9000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 732.4000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_413_generated", "manhole_dn": "manhole_414_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385873.387286560609937, 5858639.487976770848036 ], [ 1385875.017949819331989, 5858689.287253175862134 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E251", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 748.9000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_414_generated", "manhole_dn": "manhole_415_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385875.017949819331989, 5858689.287253175862134 ], [ 1385876.432928551919758, 5858739.106416343711317 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E252", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 748.9000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_415_generated", "manhole_dn": "manhole_416_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385876.432928551919758, 5858739.106416343711317 ], [ 1385878.329821793129668, 5858788.908141564577818 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E253", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 748.9000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_416_generated", "manhole_dn": "manhole_417_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385878.329821793129668, 5858788.908141564577818 ], [ 1385880.51921496167779, 5858838.69928275514394 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E254", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_417_generated", "manhole_dn": "manhole_418_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385880.51921496167779, 5858838.69928275514394 ], [ 1385882.620351102668792, 5858888.493530485779047 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E255", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_418_generated", "manhole_dn": "manhole_419_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385882.620351102668792, 5858888.493530485779047 ], [ 1385883.937443709466606, 5858938.315377607010305 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E256", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 766.10003662109375, "invlev_up": 757.20001220703125, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_419_generated", "manhole_dn": "manhole_420_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385883.937443709466606, 5858938.315377607010305 ], [ 1385885.254538560518995, 5858988.137224668636918 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E257", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 766.10003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_420_generated", "manhole_dn": "manhole_421_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385885.254538560518995, 5858988.137224668636918 ], [ 1385890.650534195825458, 5859037.630400610156357 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E258", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 766.10003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_421_generated", "manhole_dn": "manhole_422_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385890.650534195825458, 5859037.630400610156357 ], [ 1385901.777442803606391, 5859086.09239396546036 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E259", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 768.60003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 766.10003662109375, "manhole_up": "manhole_422_generated", "manhole_dn": "manhole_423_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385901.777442803606391, 5859086.09239396546036 ], [ 1385915.397954803425819, 5859134.03436760418117 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E260", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.60003662109375, "elevtn_dn": 762.79998779296875, "invlev_up": 766.10003662109375, "invlev_dn": 760.29998779296875, "manhole_up": "manhole_423_generated", "manhole_dn": "manhole_424_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385915.397954803425819, 5859134.03436760418117 ], [ 1385928.42605347908102, 5859182.139209139160812 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E261", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.79998779296875, "elevtn_dn": 762.5, "invlev_up": 760.29998779296875, "invlev_dn": 760.0, "manhole_up": "manhole_424_generated", "manhole_dn": "manhole_425_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385928.42605347908102, 5859182.139209139160812 ], [ 1385941.228082312969491, 5859230.306202415376902 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E262", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 762.5, "invlev_up": 760.0, "invlev_dn": 760.0, "manhole_up": "manhole_425_generated", "manhole_dn": "manhole_426_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385941.228082312969491, 5859230.306202415376902 ], [ 1385945.092689140234143, 5859279.734331246465445 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E263", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 762.5, "invlev_up": 760.0, "invlev_dn": 760.0, "manhole_up": "manhole_426_generated", "manhole_dn": "manhole_427_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385945.092689140234143, 5859279.734331246465445 ], [ 1385937.902412303024903, 5859328.779896341264248 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E264", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 778.0, "invlev_up": 760.0, "invlev_dn": 775.5, "manhole_up": "manhole_427_generated", "manhole_dn": "manhole_428_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.902412303024903, 5859328.779896341264248 ], [ 1385932.795075723901391, 5859378.173214216716588 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E265", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 778.0, "invlev_up": 775.5, "invlev_dn": 775.5, "manhole_up": "manhole_428_generated", "manhole_dn": "manhole_429_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385932.795075723901391, 5859378.173214216716588 ], [ 1385937.702695531537756, 5859427.770254967734218 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E266", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 778.0, "invlev_up": 775.5, "invlev_dn": 775.5, "manhole_up": "manhole_429_generated", "manhole_dn": "manhole_430_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.702695531537756, 5859427.770254967734218 ], [ 1385939.035937832202762, 5859477.50230407807976 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E267", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 795.9000244140625, "invlev_up": 775.5, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_430_generated", "manhole_dn": "manhole_431_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385939.035937832202762, 5859477.50230407807976 ], [ 1385937.883638251805678, 5859527.328234969638288 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E268", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_431_generated", "manhole_dn": "manhole_432_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.883638251805678, 5859527.328234969638288 ], [ 1385940.515994266141206, 5859576.989168248139322 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E269", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_432_generated", "manhole_dn": "manhole_433_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385940.515994266141206, 5859576.989168248139322 ], [ 1385950.701545101590455, 5859625.530176519416273 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E270", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 815.0, "invlev_up": 793.4000244140625, "invlev_dn": 812.5, "manhole_up": "manhole_433_generated", "manhole_dn": "manhole_434_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385950.701545101590455, 5859625.530176519416273 ], [ 1385970.467743494315073, 5859670.991298755630851 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E271", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 815.0, "elevtn_dn": 815.0, "invlev_up": 812.5, "invlev_dn": 812.5, "manhole_up": "manhole_434_generated", "manhole_dn": "manhole_435_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385970.467743494315073, 5859670.991298755630851 ], [ 1386011.983088220236823, 5859697.862916950136423 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E272", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 815.0, "elevtn_dn": 779.79998779296875, "invlev_up": 812.5, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_435_generated", "manhole_dn": "manhole_436_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386011.983088220236823, 5859697.862916950136423 ], [ 1386052.213596233632416, 5859727.119808158837259 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E273", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_436_generated", "manhole_dn": "manhole_437_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386052.213596233632416, 5859727.119808158837259 ], [ 1386046.501012831227854, 5859771.612671964801848 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E274", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_437_generated", "manhole_dn": "manhole_438_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386046.501012831227854, 5859771.612671964801848 ], [ 1386026.809695787727833, 5859816.873920152895153 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E275", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_438_generated", "manhole_dn": "manhole_439_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386026.809695787727833, 5859816.873920152895153 ], [ 1386030.149607364553958, 5859866.379009906202555 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_10_E276", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_10", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_439_generated", "manhole_dn": "manhole_440_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386030.149607364553958, 5859866.379009906202555 ], [ 1386045.250939248362556, 5859913.859036295674741 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 798.29998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_441_generated", "manhole_dn": "manhole_442_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384196.861816460033879, 5856829.88048410974443 ], [ 1384235.22519311751239, 5856854.977665597572923 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 793.9000244140625, "invlev_up": 798.29998779296875, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_442_generated", "manhole_dn": "manhole_443_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384235.22519311751239, 5856854.977665597572923 ], [ 1384263.450329831801355, 5856892.038370934315026 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 793.9000244140625, "invlev_up": 791.4000244140625, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_443_generated", "manhole_dn": "manhole_444_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384263.450329831801355, 5856892.038370934315026 ], [ 1384291.675466545857489, 5856929.099076271057129 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 807.60003662109375, "invlev_up": 791.4000244140625, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_444_generated", "manhole_dn": "manhole_445_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384291.675466545857489, 5856929.099076271057129 ], [ 1384319.900603260146454, 5856966.159781608730555 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_445_generated", "manhole_dn": "manhole_446_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384319.900603260146454, 5856966.159781608730555 ], [ 1384347.205867683747783, 5857003.894510924816132 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 799.0, "invlev_up": 805.10003662109375, "invlev_dn": 796.5, "manhole_up": "manhole_446_generated", "manhole_dn": "manhole_447_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384347.205867683747783, 5857003.894510924816132 ], [ 1384380.322691001230851, 5857036.360282040201128 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 799.0, "elevtn_dn": 807.60003662109375, "invlev_up": 796.5, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_447_generated", "manhole_dn": "manhole_448_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384380.322691001230851, 5857036.360282040201128 ], [ 1384415.156610523350537, 5857067.291694445535541 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_448_generated", "manhole_dn": "manhole_449_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384415.156610523350537, 5857067.291694445535541 ], [ 1384449.343575850594789, 5857098.828100205399096 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_449_generated", "manhole_dn": "manhole_450_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384449.343575850594789, 5857098.828100205399096 ], [ 1384470.004810179118067, 5857139.926174183376133 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_11_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_11", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_450_generated", "manhole_dn": "manhole_451_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384470.004810179118067, 5857139.926174183376133 ], [ 1384484.18076178082265, 5857184.301805094815791 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_452_generated", "manhole_dn": "manhole_453_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384289.06552429520525, 5856954.947841017507017 ], [ 1384305.049610810354352, 5856994.88734863139689 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_453_generated", "manhole_dn": "manhole_454_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384305.049610810354352, 5856994.88734863139689 ], [ 1384321.033697325503454, 5857034.82685624435544 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 799.0, "invlev_up": 805.10003662109375, "invlev_dn": 796.5, "manhole_up": "manhole_454_generated", "manhole_dn": "manhole_455_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384321.033697325503454, 5857034.82685624435544 ], [ 1384347.445656489115208, 5857068.672038841992617 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 799.0, "elevtn_dn": 807.60003662109375, "invlev_up": 796.5, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_455_generated", "manhole_dn": "manhole_456_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384347.445656489115208, 5857068.672038841992617 ], [ 1384374.130628447979689, 5857102.406951548531651 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_456_generated", "manhole_dn": "manhole_457_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384374.130628447979689, 5857102.406951548531651 ], [ 1384399.587644136510789, 5857137.08541233278811 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_457_generated", "manhole_dn": "manhole_458_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384399.587644136510789, 5857137.08541233278811 ], [ 1384425.04465982504189, 5857171.763873117044568 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_12_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_12", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_458_generated", "manhole_dn": "manhole_459_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384425.04465982504189, 5857171.763873117044568 ], [ 1384456.866520966170356, 5857200.577977900393307 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_15_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_15", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_15", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_459_generated", "manhole_dn": "manhole_460_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384456.866520966170356, 5857200.577977900393307 ], [ 1384480.774830641923472, 5857195.244455400854349 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_17_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_17", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_17", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 805.0, "invlev_up": 793.4000244140625, "invlev_dn": 802.5, "manhole_up": "manhole_459_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384456.866520966170356, 5857200.577977900393307 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_18_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_18", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_18", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_462_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384493.329776774393395, 5857201.952337642200291 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_19_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_19", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_19", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_462_generated", "manhole_dn": "manhole_463_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384493.329776774393395, 5857201.952337642200291 ], [ 1384511.321100181667134, 5857246.008046119473875 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_19_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_19", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_19", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_463_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384511.321100181667134, 5857246.008046119473875 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 796.29998779296875, "invlev_up": 802.5, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_464_generated", "manhole_dn": "manhole_465_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384512.484966830350459, 5857248.858029337599874 ], [ 1384550.208547196350992, 5857281.609186780638993 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 796.29998779296875, "invlev_up": 793.79998779296875, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_465_generated", "manhole_dn": "manhole_466_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384550.208547196350992, 5857281.609186780638993 ], [ 1384587.932127562351525, 5857314.360344224609435 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 809.10003662109375, "invlev_up": 793.79998779296875, "invlev_dn": 806.60003662109375, "manhole_up": "manhole_466_generated", "manhole_dn": "manhole_467_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384587.932127562351525, 5857314.360344224609435 ], [ 1384608.456866907887161, 5857358.785165345296264 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.10003662109375, "elevtn_dn": 809.10003662109375, "invlev_up": 806.60003662109375, "invlev_dn": 806.60003662109375, "manhole_up": "manhole_467_generated", "manhole_dn": "manhole_468_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384608.456866907887161, 5857358.785165345296264 ], [ 1384624.966163935838267, 5857405.935456342995167 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.10003662109375, "elevtn_dn": 794.29998779296875, "invlev_up": 806.60003662109375, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_468_generated", "manhole_dn": "manhole_469_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384624.966163935838267, 5857405.935456342995167 ], [ 1384639.938245237572119, 5857453.586039477027953 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 812.4000244140625, "invlev_up": 791.79998779296875, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_469_generated", "manhole_dn": "manhole_470_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384639.938245237572119, 5857453.586039477027953 ], [ 1384654.3423755497206, 5857501.421464210376143 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 812.4000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_470_generated", "manhole_dn": "manhole_471_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384654.3423755497206, 5857501.421464210376143 ], [ 1384665.748858094681054, 5857550.055336253717542 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 812.4000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_471_generated", "manhole_dn": "manhole_472_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384665.748858094681054, 5857550.055336253717542 ], [ 1384677.04772660904564, 5857598.717872150242329 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 818.9000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 816.4000244140625, "manhole_up": "manhole_472_generated", "manhole_dn": "manhole_473_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384677.04772660904564, 5857598.717872150242329 ], [ 1384688.346595123410225, 5857647.380408045835793 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.9000244140625, "elevtn_dn": 818.9000244140625, "invlev_up": 816.4000244140625, "invlev_dn": 816.4000244140625, "manhole_up": "manhole_473_generated", "manhole_dn": "manhole_474_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384688.346595123410225, 5857647.380408045835793 ], [ 1384699.64546363777481, 5857696.042943941429257 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.9000244140625, "elevtn_dn": 791.0, "invlev_up": 816.4000244140625, "invlev_dn": 788.5, "manhole_up": "manhole_474_generated", "manhole_dn": "manhole_475_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384699.64546363777481, 5857696.042943941429257 ], [ 1384710.944332152139395, 5857744.705479837954044 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 771.9000244140625, "invlev_up": 788.5, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_475_generated", "manhole_dn": "manhole_476_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384710.944332152139395, 5857744.705479837954044 ], [ 1384726.848783193388954, 5857791.671307560056448 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_476_generated", "manhole_dn": "manhole_477_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384726.848783193388954, 5857791.671307560056448 ], [ 1384753.929338480113074, 5857833.199649352580309 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_477_generated", "manhole_dn": "manhole_478_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384753.929338480113074, 5857833.199649352580309 ], [ 1384783.627482200739905, 5857873.006575288251042 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 791.0, "invlev_up": 769.4000244140625, "invlev_dn": 788.5, "manhole_up": "manhole_478_generated", "manhole_dn": "manhole_479_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384783.627482200739905, 5857873.006575288251042 ], [ 1384795.018452654592693, 5857920.637507135979831 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 791.0, "invlev_up": 788.5, "invlev_dn": 788.5, "manhole_up": "manhole_479_generated", "manhole_dn": "manhole_480_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384795.018452654592693, 5857920.637507135979831 ], [ 1384785.075932276435196, 5857969.445633230730891 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 820.10003662109375, "invlev_up": 788.5, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_480_generated", "manhole_dn": "manhole_481_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384785.075932276435196, 5857969.445633230730891 ], [ 1384771.479073295136914, 5858017.516749874688685 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 820.10003662109375, "invlev_up": 817.60003662109375, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_481_generated", "manhole_dn": "manhole_482_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384771.479073295136914, 5858017.516749874688685 ], [ 1384763.32518996251747, 5858066.675425447523594 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 820.10003662109375, "invlev_up": 817.60003662109375, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_482_generated", "manhole_dn": "manhole_483_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384763.32518996251747, 5858066.675425447523594 ], [ 1384757.405406558187678, 5858116.280495692044497 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 847.0, "invlev_up": 817.60003662109375, "invlev_dn": 844.5, "manhole_up": "manhole_483_generated", "manhole_dn": "manhole_484_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384757.405406558187678, 5858116.280495692044497 ], [ 1384746.211964494548738, 5858164.956996791996062 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 847.0, "invlev_up": 844.5, "invlev_dn": 844.5, "manhole_up": "manhole_484_generated", "manhole_dn": "manhole_485_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384746.211964494548738, 5858164.956996791996062 ], [ 1384738.028054837835953, 5858213.862443570047617 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 847.0, "invlev_up": 844.5, "invlev_dn": 844.5, "manhole_up": "manhole_485_generated", "manhole_dn": "manhole_486_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384738.028054837835953, 5858213.862443570047617 ], [ 1384756.479259133106098, 5858259.218586039729416 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 833.20001220703125, "invlev_up": 844.5, "invlev_dn": 830.70001220703125, "manhole_up": "manhole_486_generated", "manhole_dn": "manhole_487_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384756.479259133106098, 5858259.218586039729416 ], [ 1384792.653981153853238, 5858293.25339647103101 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 833.20001220703125, "elevtn_dn": 762.29998779296875, "invlev_up": 830.70001220703125, "invlev_dn": 759.79998779296875, "manhole_up": "manhole_487_generated", "manhole_dn": "manhole_488_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384792.653981153853238, 5858293.25339647103101 ], [ 1384839.146884107263759, 5858310.949097327888012 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.29998779296875, "elevtn_dn": 762.29998779296875, "invlev_up": 759.79998779296875, "invlev_dn": 759.79998779296875, "manhole_up": "manhole_488_generated", "manhole_dn": "manhole_489_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384839.146884107263759, 5858310.949097327888012 ], [ 1384888.517509665805846, 5858307.535864246077836 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.29998779296875, "elevtn_dn": 751.0, "invlev_up": 759.79998779296875, "invlev_dn": 748.5, "manhole_up": "manhole_489_generated", "manhole_dn": "manhole_490_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384888.517509665805846, 5858307.535864246077836 ], [ 1384936.622762819286436, 5858294.068231076002121 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.0, "elevtn_dn": 751.0, "invlev_up": 748.5, "invlev_dn": 748.5, "manhole_up": "manhole_490_generated", "manhole_dn": "manhole_491_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384936.622762819286436, 5858294.068231076002121 ], [ 1384984.637113286415115, 5858280.272530450485647 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.0, "elevtn_dn": 743.20001220703125, "invlev_up": 748.5, "invlev_dn": 740.70001220703125, "manhole_up": "manhole_491_generated", "manhole_dn": "manhole_492_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384984.637113286415115, 5858280.272530450485647 ], [ 1385032.633651287527755, 5858266.414710656739771 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 743.20001220703125, "elevtn_dn": 743.20001220703125, "invlev_up": 740.70001220703125, "invlev_dn": 740.70001220703125, "manhole_up": "manhole_492_generated", "manhole_dn": "manhole_493_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385032.633651287527755, 5858266.414710656739771 ], [ 1385081.886840383987874, 5858258.136644747108221 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 743.20001220703125, "elevtn_dn": 747.60003662109375, "invlev_up": 740.70001220703125, "invlev_dn": 745.10003662109375, "manhole_up": "manhole_493_generated", "manhole_dn": "manhole_494_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385081.886840383987874, 5858258.136644747108221 ], [ 1385131.310463621048257, 5858263.211211345158517 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.60003662109375, "elevtn_dn": 756.79998779296875, "invlev_up": 745.10003662109375, "invlev_dn": 754.29998779296875, "manhole_up": "manhole_494_generated", "manhole_dn": "manhole_495_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385131.310463621048257, 5858263.211211345158517 ], [ 1385177.729395114118233, 5858281.168494092300534 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.79998779296875, "elevtn_dn": 758.9000244140625, "invlev_up": 754.29998779296875, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_495_generated", "manhole_dn": "manhole_496_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385177.729395114118233, 5858281.168494092300534 ], [ 1385219.95651927171275, 5858307.84242575801909 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 758.9000244140625, "invlev_up": 756.4000244140625, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_496_generated", "manhole_dn": "manhole_497_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385219.95651927171275, 5858307.84242575801909 ], [ 1385261.864506913116202, 5858335.034840167500079 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 756.29998779296875, "invlev_up": 756.4000244140625, "invlev_dn": 753.79998779296875, "manhole_up": "manhole_497_generated", "manhole_dn": "manhole_498_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385261.864506913116202, 5858335.034840167500079 ], [ 1385305.658712412696332, 5858358.964500648900867 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 756.29998779296875, "invlev_up": 753.79998779296875, "invlev_dn": 753.79998779296875, "manhole_up": "manhole_498_generated", "manhole_dn": "manhole_499_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385305.658712412696332, 5858358.964500648900867 ], [ 1385350.136275847908109, 5858381.712097893469036 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 750.79998779296875, "invlev_up": 753.79998779296875, "invlev_dn": 748.29998779296875, "manhole_up": "manhole_499_generated", "manhole_dn": "manhole_500_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385350.136275847908109, 5858381.712097893469036 ], [ 1385394.617425152566284, 5858404.452682325616479 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 750.79998779296875, "elevtn_dn": 760.20001220703125, "invlev_up": 748.29998779296875, "invlev_dn": 757.70001220703125, "manhole_up": "manhole_500_generated", "manhole_dn": "manhole_501_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385394.617425152566284, 5858404.452682325616479 ], [ 1385439.245915542822331, 5858426.901898948475718 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 760.20001220703125, "elevtn_dn": 754.29998779296875, "invlev_up": 757.70001220703125, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_501_generated", "manhole_dn": "manhole_502_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385439.245915542822331, 5858426.901898948475718 ], [ 1385483.926139793125913, 5858449.248809035867453 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 754.29998779296875, "invlev_up": 751.79998779296875, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_502_generated", "manhole_dn": "manhole_503_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385483.926139793125913, 5858449.248809035867453 ], [ 1385525.860647091642022, 5858475.8632338559255 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 754.29998779296875, "invlev_up": 751.79998779296875, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_503_generated", "manhole_dn": "manhole_504_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385525.860647091642022, 5858475.8632338559255 ], [ 1385553.357332118786871, 5858517.404887572862208 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 751.70001220703125, "invlev_up": 751.79998779296875, "invlev_dn": 749.20001220703125, "manhole_up": "manhole_504_generated", "manhole_dn": "manhole_505_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385553.357332118786871, 5858517.404887572862208 ], [ 1385579.617479301057756, 5858559.686364834196866 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.70001220703125, "elevtn_dn": 751.70001220703125, "invlev_up": 749.20001220703125, "invlev_dn": 749.20001220703125, "manhole_up": "manhole_505_generated", "manhole_dn": "manhole_506_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385579.617479301057756, 5858559.686364834196866 ], [ 1385621.905693766893819, 5858585.068030893802643 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.70001220703125, "elevtn_dn": 750.9000244140625, "invlev_up": 749.20001220703125, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_506_generated", "manhole_dn": "manhole_507_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385621.905693766893819, 5858585.068030893802643 ], [ 1385664.027273919200525, 5858611.351026647724211 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 750.9000244140625, "invlev_up": 748.4000244140625, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_507_generated", "manhole_dn": "manhole_508_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385664.027273919200525, 5858611.351026647724211 ], [ 1385700.387205619364977, 5858645.507954810746014 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 750.9000244140625, "invlev_up": 748.4000244140625, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_508_generated", "manhole_dn": "manhole_509_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385700.387205619364977, 5858645.507954810746014 ], [ 1385734.601841112133116, 5858681.909404612146318 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 755.79998779296875, "invlev_up": 748.4000244140625, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_509_generated", "manhole_dn": "manhole_510_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385734.601841112133116, 5858681.909404612146318 ], [ 1385768.816476604901254, 5858718.310854412615299 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_510_generated", "manhole_dn": "manhole_511_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385768.816476604901254, 5858718.310854412615299 ], [ 1385802.200311921536922, 5858755.447309947572649 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_20_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_20", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_511_generated", "manhole_dn": "manhole_512_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385802.200311921536922, 5858755.447309947572649 ], [ 1385834.15946239954792, 5858793.844178703613579 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_21_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 765.0, "invlev_up": 753.79998779296875, "invlev_dn": 762.5, "manhole_up": "manhole_513_generated", "manhole_dn": "manhole_514_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385352.471788094611838, 5858398.70255031902343 ], [ 1385323.609449510695413, 5858430.098599229939282 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_21_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.0, "elevtn_dn": 765.0, "invlev_up": 762.5, "invlev_dn": 762.5, "manhole_up": "manhole_514_generated", "manhole_dn": "manhole_515_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385323.609449510695413, 5858430.098599229939282 ], [ 1385286.388775944709778, 5858419.306091710925102 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_21_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.0, "elevtn_dn": 758.9000244140625, "invlev_up": 762.5, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_515_generated", "manhole_dn": "manhole_516_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385286.388775944709778, 5858419.306091710925102 ], [ 1385252.458742934046313, 5858394.201654580421746 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_21_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 758.9000244140625, "invlev_up": 756.4000244140625, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_516_generated", "manhole_dn": "manhole_517_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385252.458742934046313, 5858394.201654580421746 ], [ 1385217.536378393415362, 5858369.72360460460186 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_21_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_21", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 756.79998779296875, "invlev_up": 756.4000244140625, "invlev_dn": 754.29998779296875, "manhole_up": "manhole_517_generated", "manhole_dn": "manhole_518_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385217.536378393415362, 5858369.72360460460186 ], [ 1385177.877519500209019, 5858363.975667187944055 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_23_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_23", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "manhole_up": "manhole_519_generated", "manhole_dn": "manhole_520_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384748.107251951703802, 5858475.46539437584579 ], [ 1384773.662756133358926, 5858482.028828926384449 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_23_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_23", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "manhole_up": "manhole_520_generated", "manhole_dn": "manhole_521_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384773.662756133358926, 5858482.028828926384449 ], [ 1384799.21826031524688, 5858488.592263477854431 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_24_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_24", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_24", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.9000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 760.4000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_522_generated", "manhole_dn": "manhole_523_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385831.554474999429658, 5858837.476550582796335 ], [ 1385834.933234154479578, 5858795.367517679929733 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_24_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_24", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_24", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 748.9000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_523_generated", "manhole_dn": "manhole_524_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385834.933234154479578, 5858795.367517679929733 ], [ 1385855.640895856311545, 5858836.135079927742481 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_25_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_25", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.79998779296875, "elevtn_dn": 791.20001220703125, "invlev_up": 784.29998779296875, "invlev_dn": 788.70001220703125, "manhole_up": "manhole_525_generated", "manhole_dn": "manhole_526_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385425.871741503709927, 5858809.522038951516151 ], [ 1385446.216239683330059, 5858844.397748519666493 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_25_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_25", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.20001220703125, "elevtn_dn": 791.20001220703125, "invlev_up": 788.70001220703125, "invlev_dn": 788.70001220703125, "manhole_up": "manhole_526_generated", "manhole_dn": "manhole_527_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385446.216239683330059, 5858844.397748519666493 ], [ 1385453.998638280900195, 5858886.437654017470777 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_25_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_25", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 791.20001220703125, "elevtn_dn": 783.0, "invlev_up": 788.70001220703125, "invlev_dn": 780.5, "manhole_up": "manhole_527_generated", "manhole_dn": "manhole_528_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385453.998638280900195, 5858886.437654017470777 ], [ 1385472.218053022632375, 5858925.273072509095073 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_26_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_26", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_26", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.9000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 760.4000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_522_generated", "manhole_dn": "manhole_524_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385831.554474999429658, 5858837.476550582796335 ], [ 1385855.640895856311545, 5858836.135079927742481 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_29_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_29", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_29", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_529_generated", "manhole_dn": "manhole_530_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385861.372513797832653, 5858893.832569030113518 ], [ 1385844.630084188189358, 5858865.848266057670116 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_29_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_29", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_29", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 762.9000244140625, "invlev_up": 757.20001220703125, "invlev_dn": 760.4000244140625, "manhole_up": "manhole_530_generated", "manhole_dn": "manhole_522_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385844.630084188189358, 5858865.848266057670116 ], [ 1385831.554474999429658, 5858837.476550582796335 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 769.4000244140625, "invlev_up": 766.9000244140625, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_531_generated", "manhole_dn": "manhole_532_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387137.22300889948383, 5858981.723106959834695 ], [ 1387148.04859330272302, 5859026.366797789931297 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 762.60003662109375, "invlev_up": 766.9000244140625, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_532_generated", "manhole_dn": "manhole_533_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387148.04859330272302, 5859026.366797789931297 ], [ 1387119.95937648974359, 5859056.934598693624139 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 762.60003662109375, "invlev_up": 760.10003662109375, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_533_generated", "manhole_dn": "manhole_534_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387119.95937648974359, 5859056.934598693624139 ], [ 1387074.832296247361228, 5859065.30100557859987 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 755.79998779296875, "invlev_up": 760.10003662109375, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_534_generated", "manhole_dn": "manhole_535_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387074.832296247361228, 5859065.30100557859987 ], [ 1387030.356415221933275, 5859076.86137125454843 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 772.4000244140625, "invlev_up": 753.29998779296875, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_535_generated", "manhole_dn": "manhole_536_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387030.356415221933275, 5859076.86137125454843 ], [ 1386986.427998587489128, 5859090.309648380614817 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 761.60003662109375, "invlev_up": 769.9000244140625, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_536_generated", "manhole_dn": "manhole_537_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386986.427998587489128, 5859090.309648380614817 ], [ 1386945.966695382725447, 5859111.788386604748666 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_537_generated", "manhole_dn": "manhole_538_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386945.966695382725447, 5859111.788386604748666 ], [ 1386905.77102447184734, 5859134.105928846634924 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_30_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_30", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_538_generated", "manhole_dn": "manhole_539_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386905.77102447184734, 5859134.105928846634924 ], [ 1386871.537448140559718, 5859162.609670763835311 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_539_generated", "manhole_dn": "manhole_540_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386871.537448140559718, 5859162.609670763835311 ], [ 1386921.106019288301468, 5859163.103915391489863 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 772.4000244140625, "invlev_up": 759.10003662109375, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_540_generated", "manhole_dn": "manhole_541_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386921.106019288301468, 5859163.103915391489863 ], [ 1386970.627896018791944, 5859161.624508504755795 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 772.4000244140625, "invlev_up": 769.9000244140625, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_541_generated", "manhole_dn": "manhole_542_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386970.627896018791944, 5859161.624508504755795 ], [ 1387019.993600395740941, 5859157.412991388700902 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 781.10003662109375, "invlev_up": 769.9000244140625, "invlev_dn": 778.60003662109375, "manhole_up": "manhole_542_generated", "manhole_dn": "manhole_543_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387019.993600395740941, 5859157.412991388700902 ], [ 1387069.191225855611265, 5859151.340004274621606 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 781.10003662109375, "elevtn_dn": 781.10003662109375, "invlev_up": 778.60003662109375, "invlev_dn": 778.60003662109375, "manhole_up": "manhole_543_generated", "manhole_dn": "manhole_544_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387069.191225855611265, 5859151.340004274621606 ], [ 1387118.547863835236058, 5859146.828392788767815 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 781.10003662109375, "elevtn_dn": 786.4000244140625, "invlev_up": 778.60003662109375, "invlev_dn": 783.9000244140625, "manhole_up": "manhole_544_generated", "manhole_dn": "manhole_545_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387118.547863835236058, 5859146.828392788767815 ], [ 1387167.916038708761334, 5859151.025294326245785 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.4000244140625, "elevtn_dn": 786.4000244140625, "invlev_up": 783.9000244140625, "invlev_dn": 783.9000244140625, "manhole_up": "manhole_545_generated", "manhole_dn": "manhole_546_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387167.916038708761334, 5859151.025294326245785 ], [ 1387217.282604865729809, 5859155.523034786805511 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.4000244140625, "elevtn_dn": 787.60003662109375, "invlev_up": 783.9000244140625, "invlev_dn": 785.10003662109375, "manhole_up": "manhole_546_generated", "manhole_dn": "manhole_547_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387217.282604865729809, 5859155.523034786805511 ], [ 1387266.649171022465453, 5859160.020775248296559 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.60003662109375, "elevtn_dn": 787.60003662109375, "invlev_up": 785.10003662109375, "invlev_dn": 785.10003662109375, "manhole_up": "manhole_547_generated", "manhole_dn": "manhole_548_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387266.649171022465453, 5859160.020775248296559 ], [ 1387315.831188223091885, 5859165.716172898188233 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.60003662109375, "elevtn_dn": 790.4000244140625, "invlev_up": 785.10003662109375, "invlev_dn": 787.9000244140625, "manhole_up": "manhole_548_generated", "manhole_dn": "manhole_549_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387315.831188223091885, 5859165.716172898188233 ], [ 1387364.261764668161049, 5859176.288154195994139 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 790.4000244140625, "elevtn_dn": 790.4000244140625, "invlev_up": 787.9000244140625, "invlev_dn": 787.9000244140625, "manhole_up": "manhole_549_generated", "manhole_dn": "manhole_550_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387364.261764668161049, 5859176.288154195994139 ], [ 1387411.186259990092367, 5859192.118345031514764 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 790.4000244140625, "elevtn_dn": 789.10003662109375, "invlev_up": 787.9000244140625, "invlev_dn": 786.60003662109375, "manhole_up": "manhole_550_generated", "manhole_dn": "manhole_551_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387411.186259990092367, 5859192.118345031514764 ], [ 1387455.544592748628929, 5859213.906051598489285 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 789.10003662109375, "elevtn_dn": 817.20001220703125, "invlev_up": 786.60003662109375, "invlev_dn": 814.70001220703125, "manhole_up": "manhole_551_generated", "manhole_dn": "manhole_552_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387455.544592748628929, 5859213.906051598489285 ], [ 1387490.610425172373652, 5859248.94134864397347 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 817.20001220703125, "elevtn_dn": 818.20001220703125, "invlev_up": 814.70001220703125, "invlev_dn": 815.70001220703125, "manhole_up": "manhole_552_generated", "manhole_dn": "manhole_553_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387490.610425172373652, 5859248.94134864397347 ], [ 1387525.979065561201423, 5859283.669168318621814 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.20001220703125, "elevtn_dn": 818.20001220703125, "invlev_up": 815.70001220703125, "invlev_dn": 815.70001220703125, "manhole_up": "manhole_553_generated", "manhole_dn": "manhole_554_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387525.979065561201423, 5859283.669168318621814 ], [ 1387563.532416822388768, 5859316.0270627560094 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.20001220703125, "elevtn_dn": 802.79998779296875, "invlev_up": 815.70001220703125, "invlev_dn": 800.29998779296875, "manhole_up": "manhole_554_generated", "manhole_dn": "manhole_555_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387563.532416822388768, 5859316.0270627560094 ], [ 1387601.085768083808944, 5859348.384957193396986 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.79998779296875, "elevtn_dn": 837.70001220703125, "invlev_up": 800.29998779296875, "invlev_dn": 835.20001220703125, "manhole_up": "manhole_555_generated", "manhole_dn": "manhole_556_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387601.085768083808944, 5859348.384957193396986 ], [ 1387638.639119345229119, 5859380.742851630784571 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 837.70001220703125, "elevtn_dn": 837.70001220703125, "invlev_up": 835.20001220703125, "invlev_dn": 835.20001220703125, "manhole_up": "manhole_556_generated", "manhole_dn": "manhole_557_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387638.639119345229119, 5859380.742851630784571 ], [ 1387676.192470606416464, 5859413.100746068172157 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 837.70001220703125, "elevtn_dn": 828.79998779296875, "invlev_up": 835.20001220703125, "invlev_dn": 826.29998779296875, "manhole_up": "manhole_557_generated", "manhole_dn": "manhole_558_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387676.192470606416464, 5859413.100746068172157 ], [ 1387713.745821867836639, 5859445.45864050462842 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 828.79998779296875, "elevtn_dn": 828.79998779296875, "invlev_up": 826.29998779296875, "invlev_dn": 826.29998779296875, "manhole_up": "manhole_558_generated", "manhole_dn": "manhole_559_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387713.745821867836639, 5859445.45864050462842 ], [ 1387750.394377880264074, 5859478.825171477161348 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 828.79998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 826.29998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_559_generated", "manhole_dn": "manhole_560_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387750.394377880264074, 5859478.825171477161348 ], [ 1387786.626276910537854, 5859512.656178202480078 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 851.79998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_560_generated", "manhole_dn": "manhole_561_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387786.626276910537854, 5859512.656178202480078 ], [ 1387822.858175940578803, 5859546.487184926867485 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 851.79998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_561_generated", "manhole_dn": "manhole_562_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387822.858175940578803, 5859546.487184926867485 ], [ 1387850.662340233800933, 5859586.980695966631174 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 891.20001220703125, "invlev_up": 851.79998779296875, "invlev_dn": 888.70001220703125, "manhole_up": "manhole_562_generated", "manhole_dn": "manhole_563_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387850.662340233800933, 5859586.980695966631174 ], [ 1387868.193221996771172, 5859633.330900657922029 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 891.20001220703125, "elevtn_dn": 876.20001220703125, "invlev_up": 888.70001220703125, "invlev_dn": 873.70001220703125, "manhole_up": "manhole_563_generated", "manhole_dn": "manhole_564_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387868.193221996771172, 5859633.330900657922029 ], [ 1387885.535610173596069, 5859679.769344814121723 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 876.20001220703125, "elevtn_dn": 876.20001220703125, "invlev_up": 873.70001220703125, "invlev_dn": 873.70001220703125, "manhole_up": "manhole_564_generated", "manhole_dn": "manhole_565_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387885.535610173596069, 5859679.769344814121723 ], [ 1387902.854485532967374, 5859726.216552678495646 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 876.20001220703125, "elevtn_dn": 898.29998779296875, "invlev_up": 873.70001220703125, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_565_generated", "manhole_dn": "manhole_566_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387902.854485532967374, 5859726.216552678495646 ], [ 1387920.137465380365029, 5859772.67713953461498 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 898.29998779296875, "invlev_up": 895.79998779296875, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_566_generated", "manhole_dn": "manhole_567_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387920.137465380365029, 5859772.67713953461498 ], [ 1387937.420445227529854, 5859819.137726389802992 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 898.29998779296875, "invlev_up": 895.79998779296875, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_567_generated", "manhole_dn": "manhole_568_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387937.420445227529854, 5859819.137726389802992 ], [ 1387948.863530882401392, 5859867.082766367122531 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 918.5, "invlev_up": 895.79998779296875, "invlev_dn": 916.0, "manhole_up": "manhole_568_generated", "manhole_dn": "manhole_569_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387948.863530882401392, 5859867.082766367122531 ], [ 1387950.013254075078294, 5859916.565449987538159 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 918.5, "invlev_up": 916.0, "invlev_dn": 916.0, "manhole_up": "manhole_569_generated", "manhole_dn": "manhole_570_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387950.013254075078294, 5859916.565449987538159 ], [ 1387947.430782878771424, 5859966.047936389222741 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 918.5, "invlev_up": 916.0, "invlev_dn": 916.0, "manhole_up": "manhole_570_generated", "manhole_dn": "manhole_571_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387947.430782878771424, 5859966.047936389222741 ], [ 1387943.997958281077445, 5860015.499966060742736 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 948.60003662109375, "invlev_up": 916.0, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_571_generated", "manhole_dn": "manhole_572_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387943.997958281077445, 5860015.499966060742736 ], [ 1387940.565133683150634, 5860064.951995733194053 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 948.60003662109375, "invlev_up": 946.10003662109375, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_572_generated", "manhole_dn": "manhole_573_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.565133683150634, 5860064.951995733194053 ], [ 1387945.371777657186612, 5860113.959104515612125 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 948.60003662109375, "invlev_up": 946.10003662109375, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_573_generated", "manhole_dn": "manhole_574_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387945.371777657186612, 5860113.959104515612125 ], [ 1387964.117816498270258, 5860159.736532494425774 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 940.5, "invlev_up": 946.10003662109375, "invlev_dn": 938.0, "manhole_up": "manhole_574_generated", "manhole_dn": "manhole_575_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387964.117816498270258, 5860159.736532494425774 ], [ 1387984.093857799191028, 5860205.104420888237655 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 940.5, "invlev_up": 938.0, "invlev_dn": 938.0, "manhole_up": "manhole_575_generated", "manhole_dn": "manhole_576_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387984.093857799191028, 5860205.104420888237655 ], [ 1388004.069899099878967, 5860250.472309282049537 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 940.5, "invlev_up": 938.0, "invlev_dn": 938.0, "manhole_up": "manhole_576_generated", "manhole_dn": "manhole_577_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388004.069899099878967, 5860250.472309282049537 ], [ 1388027.68692572391592, 5860293.896034284494817 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 971.70001220703125, "invlev_up": 938.0, "invlev_dn": 969.20001220703125, "manhole_up": "manhole_577_generated", "manhole_dn": "manhole_578_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388027.68692572391592, 5860293.896034284494817 ], [ 1388060.096315970877185, 5860331.348726416006684 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 971.70001220703125, "elevtn_dn": 935.5, "invlev_up": 969.20001220703125, "invlev_dn": 933.0, "manhole_up": "manhole_578_generated", "manhole_dn": "manhole_579_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388060.096315970877185, 5860331.348726416006684 ], [ 1388092.967688721138984, 5860368.453448176383972 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 935.5, "invlev_up": 933.0, "invlev_dn": 933.0, "manhole_up": "manhole_579_generated", "manhole_dn": "manhole_580_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388092.967688721138984, 5860368.453448176383972 ], [ 1388119.020827289205045, 5860410.510251956991851 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 949.9000244140625, "invlev_up": 933.0, "invlev_dn": 947.4000244140625, "manhole_up": "manhole_580_generated", "manhole_dn": "manhole_581_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388119.020827289205045, 5860410.510251956991851 ], [ 1388143.407622833969072, 5860453.667774203233421 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 949.9000244140625, "elevtn_dn": 924.60003662109375, "invlev_up": 947.4000244140625, "invlev_dn": 922.10003662109375, "manhole_up": "manhole_581_generated", "manhole_dn": "manhole_582_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388143.407622833969072, 5860453.667774203233421 ], [ 1388167.794418378733099, 5860496.82529644947499 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 924.60003662109375, "elevtn_dn": 924.60003662109375, "invlev_up": 922.10003662109375, "invlev_dn": 922.10003662109375, "manhole_up": "manhole_582_generated", "manhole_dn": "manhole_583_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388167.794418378733099, 5860496.82529644947499 ], [ 1388187.41186453984119, 5860542.097804954275489 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 924.60003662109375, "elevtn_dn": 942.4000244140625, "invlev_up": 922.10003662109375, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_583_generated", "manhole_dn": "manhole_584_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388187.41186453984119, 5860542.097804954275489 ], [ 1388193.385166377527639, 5860591.251542154699564 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 942.4000244140625, "invlev_up": 939.9000244140625, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_584_generated", "manhole_dn": "manhole_585_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388193.385166377527639, 5860591.251542154699564 ], [ 1388198.812296225922182, 5860640.524595490656793 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 942.4000244140625, "invlev_up": 939.9000244140625, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_585_generated", "manhole_dn": "manhole_586_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388198.812296225922182, 5860640.524595490656793 ], [ 1388204.239426074549556, 5860689.7976488256827 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 955.0, "invlev_up": 939.9000244140625, "invlev_dn": 952.5, "manhole_up": "manhole_586_generated", "manhole_dn": "manhole_587_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388204.239426074549556, 5860689.7976488256827 ], [ 1388184.484932377934456, 5860730.700381714850664 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E48", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_587_generated", "manhole_dn": "manhole_588_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388184.484932377934456, 5860730.700381714850664 ], [ 1388159.550175313837826, 5860759.392759991809726 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E49", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_588_generated", "manhole_dn": "manhole_589_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388159.550175313837826, 5860759.392759991809726 ], [ 1388171.988544700434431, 5860807.377908634953201 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E50", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_589_generated", "manhole_dn": "manhole_590_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388171.988544700434431, 5860807.377908634953201 ], [ 1388215.013825689908117, 5860825.214942933060229 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E51", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 941.10003662109375, "invlev_up": 952.5, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_590_generated", "manhole_dn": "manhole_591_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388215.013825689908117, 5860825.214942933060229 ], [ 1388264.397385431453586, 5860829.298032846301794 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E52", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_591_generated", "manhole_dn": "manhole_592_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388264.397385431453586, 5860829.298032846301794 ], [ 1388313.062299854354933, 5860837.304878970608115 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E53", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 937.5, "invlev_up": 938.60003662109375, "invlev_dn": 935.0, "manhole_up": "manhole_592_generated", "manhole_dn": "manhole_593_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388313.062299854354933, 5860837.304878970608115 ], [ 1388360.993895401246846, 5860849.948045967146754 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E54", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.5, "elevtn_dn": 937.5, "invlev_up": 935.0, "invlev_dn": 935.0, "manhole_up": "manhole_593_generated", "manhole_dn": "manhole_594_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388360.993895401246846, 5860849.948045967146754 ], [ 1388408.925490947905928, 5860862.591212964616716 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E55", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.5, "elevtn_dn": 937.60003662109375, "invlev_up": 935.0, "invlev_dn": 935.10003662109375, "manhole_up": "manhole_594_generated", "manhole_dn": "manhole_595_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388408.925490947905928, 5860862.591212964616716 ], [ 1388458.220990223577246, 5860866.957201769575477 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E56", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.60003662109375, "elevtn_dn": 937.60003662109375, "invlev_up": 935.10003662109375, "invlev_dn": 935.10003662109375, "manhole_up": "manhole_595_generated", "manhole_dn": "manhole_596_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388458.220990223577246, 5860866.957201769575477 ], [ 1388507.336333080893382, 5860873.218384950421751 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E57", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.60003662109375, "elevtn_dn": 941.20001220703125, "invlev_up": 935.10003662109375, "invlev_dn": 938.70001220703125, "manhole_up": "manhole_596_generated", "manhole_dn": "manhole_597_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388507.336333080893382, 5860873.218384950421751 ], [ 1388556.215695114107803, 5860881.470384138636291 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E58", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.20001220703125, "elevtn_dn": 941.20001220703125, "invlev_up": 938.70001220703125, "invlev_dn": 938.70001220703125, "manhole_up": "manhole_597_generated", "manhole_dn": "manhole_598_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388556.215695114107803, 5860881.470384138636291 ], [ 1388604.556662159739062, 5860892.361969010904431 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E59", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 941.20001220703125, "elevtn_dn": 943.10003662109375, "invlev_up": 938.70001220703125, "invlev_dn": 940.60003662109375, "manhole_up": "manhole_598_generated", "manhole_dn": "manhole_599_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388604.556662159739062, 5860892.361969010904431 ], [ 1388653.59940263046883, 5860897.15789801068604 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E60", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 943.10003662109375, "elevtn_dn": 943.10003662109375, "invlev_up": 940.60003662109375, "invlev_dn": 940.60003662109375, "manhole_up": "manhole_599_generated", "manhole_dn": "manhole_600_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388653.59940263046883, 5860897.15789801068604 ], [ 1388700.080393208190799, 5860881.090511013753712 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E61", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 943.10003662109375, "elevtn_dn": 946.10003662109375, "invlev_up": 940.60003662109375, "invlev_dn": 943.60003662109375, "manhole_up": "manhole_600_generated", "manhole_dn": "manhole_601_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388700.080393208190799, 5860881.090511013753712 ], [ 1388732.687003659084439, 5860844.794781206175685 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E62", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 946.10003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 943.60003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_601_generated", "manhole_dn": "manhole_602_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388732.687003659084439, 5860844.794781206175685 ], [ 1388755.953327334951609, 5860801.023035684600472 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E63", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 950.10003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_602_generated", "manhole_dn": "manhole_603_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388755.953327334951609, 5860801.023035684600472 ], [ 1388778.23369869007729, 5860756.84024004638195 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E64", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 950.10003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_603_generated", "manhole_dn": "manhole_604_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388778.23369869007729, 5860756.84024004638195 ], [ 1388792.950793598080054, 5860709.504263866692781 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E65", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 953.79998779296875, "invlev_up": 950.10003662109375, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_604_generated", "manhole_dn": "manhole_605_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388792.950793598080054, 5860709.504263866692781 ], [ 1388807.667888506315649, 5860662.168287687934935 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E66", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_605_generated", "manhole_dn": "manhole_606_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388807.667888506315649, 5860662.168287687934935 ], [ 1388819.224422588944435, 5860613.968191100284457 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E67", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 955.70001220703125, "invlev_up": 951.29998779296875, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_606_generated", "manhole_dn": "manhole_607_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388819.224422588944435, 5860613.968191100284457 ], [ 1388830.63825476472266, 5860565.72907877061516 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E68", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_607_generated", "manhole_dn": "manhole_608_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388830.63825476472266, 5860565.72907877061516 ], [ 1388842.052086940500885, 5860517.489966440014541 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E69", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_608_generated", "manhole_dn": "manhole_609_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388842.052086940500885, 5860517.489966440014541 ], [ 1388862.77624000934884, 5860472.578981296159327 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E70", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 964.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_609_generated", "manhole_dn": "manhole_610_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388862.77624000934884, 5860472.578981296159327 ], [ 1388884.529400010826066, 5860428.03588358964771 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E71", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 951.29998779296875, "invlev_up": 962.20001220703125, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_610_generated", "manhole_dn": "manhole_611_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388884.529400010826066, 5860428.03588358964771 ], [ 1388906.282637836178765, 5860383.492823889479041 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E72", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_611_generated", "manhole_dn": "manhole_612_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388906.282637836178765, 5860383.492823889479041 ], [ 1388933.946375871310011, 5860342.419800435192883 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_32_E73", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_32", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_612_generated", "manhole_dn": "manhole_613_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388933.946375871310011, 5860342.419800435192883 ], [ 1388962.240715913940221, 5860301.717001453973353 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 752.29998779296875, "invlev_up": 759.10003662109375, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_539_generated", "manhole_dn": "manhole_614_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386871.537448140559718, 5859162.609670763835311 ], [ 1386825.19834817154333, 5859175.156894122250378 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 752.29998779296875, "invlev_up": 749.79998779296875, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_614_generated", "manhole_dn": "manhole_615_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386825.19834817154333, 5859175.156894122250378 ], [ 1386779.333999397465959, 5859189.44842192158103 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 738.0, "invlev_up": 749.79998779296875, "invlev_dn": 735.5, "manhole_up": "manhole_615_generated", "manhole_dn": "manhole_616_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386779.333999397465959, 5859189.44842192158103 ], [ 1386733.445003136992455, 5859203.660136871039867 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 738.0, "invlev_up": 735.5, "invlev_dn": 735.5, "manhole_up": "manhole_616_generated", "manhole_dn": "manhole_617_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386733.445003136992455, 5859203.660136871039867 ], [ 1386687.508546756347641, 5859217.718167688697577 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 763.29998779296875, "invlev_up": 735.5, "invlev_dn": 760.79998779296875, "manhole_up": "manhole_617_generated", "manhole_dn": "manhole_618_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386687.508546756347641, 5859217.718167688697577 ], [ 1386641.572090375469998, 5859231.776198507286608 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 763.29998779296875, "elevtn_dn": 763.29998779296875, "invlev_up": 760.79998779296875, "invlev_dn": 760.79998779296875, "manhole_up": "manhole_618_generated", "manhole_dn": "manhole_619_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386641.572090375469998, 5859231.776198507286608 ], [ 1386595.451642262749374, 5859245.168246414512396 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 763.29998779296875, "elevtn_dn": 754.60003662109375, "invlev_up": 760.79998779296875, "invlev_dn": 752.10003662109375, "manhole_up": "manhole_619_generated", "manhole_dn": "manhole_620_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386595.451642262749374, 5859245.168246414512396 ], [ 1386548.813360751140863, 5859256.685926430858672 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.60003662109375, "elevtn_dn": 754.60003662109375, "invlev_up": 752.10003662109375, "invlev_dn": 752.10003662109375, "manhole_up": "manhole_620_generated", "manhole_dn": "manhole_621_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386548.813360751140863, 5859256.685926430858672 ], [ 1386502.175079239532351, 5859268.203606447204947 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 754.60003662109375, "elevtn_dn": 742.5, "invlev_up": 752.10003662109375, "invlev_dn": 740.0, "manhole_up": "manhole_621_generated", "manhole_dn": "manhole_622_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386502.175079239532351, 5859268.203606447204947 ], [ 1386455.354356503346935, 5859278.943273726850748 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 742.5, "invlev_up": 740.0, "invlev_dn": 740.0, "manhole_up": "manhole_622_generated", "manhole_dn": "manhole_623_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386455.354356503346935, 5859278.943273726850748 ], [ 1386408.879239794565365, 5859290.671229789964855 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 717.60003662109375, "invlev_up": 740.0, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_623_generated", "manhole_dn": "manhole_624_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386408.879239794565365, 5859290.671229789964855 ], [ 1386364.691368696978316, 5859309.518465746194124 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 717.60003662109375, "invlev_up": 715.10003662109375, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_624_generated", "manhole_dn": "manhole_625_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386364.691368696978316, 5859309.518465746194124 ], [ 1386320.503497599391267, 5859328.365701701492071 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_33_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_33", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 711.0, "invlev_up": 715.10003662109375, "invlev_dn": 708.5, "manhole_up": "manhole_625_generated", "manhole_dn": "manhole_626_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386320.503497599391267, 5859328.365701701492071 ], [ 1386273.173811787506565, 5859335.36546028777957 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 953.70001220703125, "invlev_up": 948.79998779296875, "invlev_dn": 951.20001220703125, "manhole_up": "manhole_10_generated", "manhole_dn": "manhole_627_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388946.301100668497384, 5860414.883977899327874 ], [ 1388922.246059404918924, 5860458.418739438988268 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.70001220703125, "elevtn_dn": 953.70001220703125, "invlev_up": 951.20001220703125, "invlev_dn": 951.20001220703125, "manhole_up": "manhole_627_generated", "manhole_dn": "manhole_628_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388922.246059404918924, 5860458.418739438988268 ], [ 1388900.295977992936969, 5860503.075897979550064 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 951.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_628_generated", "manhole_dn": "manhole_629_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388900.295977992936969, 5860503.075897979550064 ], [ 1388878.345896581187844, 5860547.733056520111859 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 953.79998779296875, "invlev_up": 953.20001220703125, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_629_generated", "manhole_dn": "manhole_630_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388878.345896581187844, 5860547.733056520111859 ], [ 1388856.887740465346724, 5860592.570927501656115 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_630_generated", "manhole_dn": "manhole_631_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388856.887740465346724, 5860592.570927501656115 ], [ 1388853.076019846601412, 5860641.795407227240503 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_631_generated", "manhole_dn": "manhole_632_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388853.076019846601412, 5860641.795407227240503 ], [ 1388856.119826921960339, 5860691.462329030036926 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 952.5, "invlev_up": 951.29998779296875, "invlev_dn": 950.0, "manhole_up": "manhole_632_generated", "manhole_dn": "manhole_633_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388856.119826921960339, 5860691.462329030036926 ], [ 1388859.163633997086436, 5860741.12925083283335 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.5, "elevtn_dn": 952.5, "invlev_up": 950.0, "invlev_dn": 950.0, "manhole_up": "manhole_633_generated", "manhole_dn": "manhole_634_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388859.163633997086436, 5860741.12925083283335 ], [ 1388862.207441072445363, 5860790.796172635629773 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.5, "elevtn_dn": 945.5, "invlev_up": 950.0, "invlev_dn": 943.0, "manhole_up": "manhole_634_generated", "manhole_dn": "manhole_635_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388862.207441072445363, 5860790.796172635629773 ], [ 1388866.356326055014506, 5860840.344227194786072 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 945.5, "invlev_up": 943.0, "invlev_dn": 943.0, "manhole_up": "manhole_635_generated", "manhole_dn": "manhole_636_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388866.356326055014506, 5860840.344227194786072 ], [ 1388873.944740658160299, 5860889.522310186177492 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 945.5, "invlev_up": 943.0, "invlev_dn": 943.0, "manhole_up": "manhole_636_generated", "manhole_dn": "manhole_637_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388873.944740658160299, 5860889.522310186177492 ], [ 1388883.17427325528115, 5860938.398467163555324 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 937.4000244140625, "invlev_up": 943.0, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_637_generated", "manhole_dn": "manhole_638_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388883.17427325528115, 5860938.398467163555324 ], [ 1388890.216840920504183, 5860987.212368851527572 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 937.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_638_generated", "manhole_dn": "manhole_639_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388890.216840920504183, 5860987.212368851527572 ], [ 1388884.322194910608232, 5861036.62209493201226 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 937.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_639_generated", "manhole_dn": "manhole_640_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388884.322194910608232, 5861036.62209493201226 ], [ 1388878.427548900712281, 5861086.031821011565626 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_640_generated", "manhole_dn": "manhole_641_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388878.427548900712281, 5861086.031821011565626 ], [ 1388872.532902890816331, 5861135.441547092050314 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 927.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_641_generated", "manhole_dn": "manhole_642_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388872.532902890816331, 5861135.441547092050314 ], [ 1388866.63825688092038, 5861184.851273172535002 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 927.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_642_generated", "manhole_dn": "manhole_643_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388866.63825688092038, 5861184.851273172535002 ], [ 1388854.620840607210994, 5861232.489912945777178 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 926.60003662109375, "invlev_up": 927.9000244140625, "invlev_dn": 924.10003662109375, "manhole_up": "manhole_643_generated", "manhole_dn": "manhole_644_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388854.620840607210994, 5861232.489912945777178 ], [ 1388833.22756120422855, 5861277.416469449177384 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 926.60003662109375, "elevtn_dn": 926.60003662109375, "invlev_up": 924.10003662109375, "invlev_dn": 924.10003662109375, "manhole_up": "manhole_644_generated", "manhole_dn": "manhole_645_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388833.22756120422855, 5861277.416469449177384 ], [ 1388811.834281801246107, 5861322.343025953508914 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 926.60003662109375, "elevtn_dn": 931.10003662109375, "invlev_up": 924.10003662109375, "invlev_dn": 928.60003662109375, "manhole_up": "manhole_645_generated", "manhole_dn": "manhole_646_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388811.834281801246107, 5861322.343025953508914 ], [ 1388790.441002398030832, 5861367.26958245690912 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 931.10003662109375, "elevtn_dn": 922.20001220703125, "invlev_up": 928.60003662109375, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_646_generated", "manhole_dn": "manhole_647_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388790.441002398030832, 5861367.26958245690912 ], [ 1388769.047722995048389, 5861412.196138960309327 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 922.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_647_generated", "manhole_dn": "manhole_648_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388769.047722995048389, 5861412.196138960309327 ], [ 1388747.654443592065945, 5861457.122695464640856 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 922.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_648_generated", "manhole_dn": "manhole_649_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388747.654443592065945, 5861457.122695464640856 ], [ 1388725.026126575190574, 5861501.410491958260536 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_649_generated", "manhole_dn": "manhole_650_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388725.026126575190574, 5861501.410491958260536 ], [ 1388700.725248141447082, 5861544.833241644315422 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_650_generated", "manhole_dn": "manhole_651_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388700.725248141447082, 5861544.833241644315422 ], [ 1388676.42436970770359, 5861588.255991329438984 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_651_generated", "manhole_dn": "manhole_652_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388676.42436970770359, 5861588.255991329438984 ], [ 1388632.324464634526521, 5861606.441272142343223 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 898.4000244140625, "invlev_up": 897.70001220703125, "invlev_dn": 895.9000244140625, "manhole_up": "manhole_652_generated", "manhole_dn": "manhole_653_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388632.324464634526521, 5861606.441272142343223 ], [ 1388583.463808472501114, 5861611.105615227483213 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.4000244140625, "elevtn_dn": 898.4000244140625, "invlev_up": 895.9000244140625, "invlev_dn": 895.9000244140625, "manhole_up": "manhole_653_generated", "manhole_dn": "manhole_654_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388583.463808472501114, 5861611.105615227483213 ], [ 1388534.764012826373801, 5861604.222017968073487 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 898.4000244140625, "elevtn_dn": 903.60003662109375, "invlev_up": 895.9000244140625, "invlev_dn": 901.10003662109375, "manhole_up": "manhole_654_generated", "manhole_dn": "manhole_655_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388534.764012826373801, 5861604.222017968073487 ], [ 1388489.566489090910181, 5861583.40731808822602 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 903.60003662109375, "elevtn_dn": 903.60003662109375, "invlev_up": 901.10003662109375, "invlev_dn": 901.10003662109375, "manhole_up": "manhole_655_generated", "manhole_dn": "manhole_656_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388489.566489090910181, 5861583.40731808822602 ], [ 1388444.204915680922568, 5861563.162508152425289 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 903.60003662109375, "elevtn_dn": 906.4000244140625, "invlev_up": 901.10003662109375, "invlev_dn": 903.9000244140625, "manhole_up": "manhole_656_generated", "manhole_dn": "manhole_657_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388444.204915680922568, 5861563.162508152425289 ], [ 1388394.858231473481283, 5861556.761520680040121 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 906.4000244140625, "elevtn_dn": 906.4000244140625, "invlev_up": 903.9000244140625, "invlev_dn": 903.9000244140625, "manhole_up": "manhole_657_generated", "manhole_dn": "manhole_658_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388394.858231473481283, 5861556.761520680040121 ], [ 1388350.680838279658929, 5861570.408674017526209 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 906.4000244140625, "elevtn_dn": 900.20001220703125, "invlev_up": 903.9000244140625, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_658_generated", "manhole_dn": "manhole_659_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388350.680838279658929, 5861570.408674017526209 ], [ 1388310.581732882419601, 5861599.872713611461222 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_659_generated", "manhole_dn": "manhole_660_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388310.581732882419601, 5861599.872713611461222 ], [ 1388271.039625711739063, 5861629.969603477045894 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 890.0, "invlev_up": 897.70001220703125, "invlev_dn": 887.5, "manhole_up": "manhole_660_generated", "manhole_dn": "manhole_661_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388271.039625711739063, 5861629.969603477045894 ], [ 1388236.722210306907073, 5861666.002683873288333 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 890.0, "invlev_up": 887.5, "invlev_dn": 887.5, "manhole_up": "manhole_661_generated", "manhole_dn": "manhole_662_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388236.722210306907073, 5861666.002683873288333 ], [ 1388202.404794902307913, 5861702.035764269530773 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 890.0, "invlev_up": 887.5, "invlev_dn": 887.5, "manhole_up": "manhole_662_generated", "manhole_dn": "manhole_663_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388202.404794902307913, 5861702.035764269530773 ], [ 1388168.087379497475922, 5861738.068844665773213 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 885.9000244140625, "invlev_up": 887.5, "invlev_dn": 883.4000244140625, "manhole_up": "manhole_663_generated", "manhole_dn": "manhole_664_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388168.087379497475922, 5861738.068844665773213 ], [ 1388133.769964092643932, 5861774.101925062015653 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 885.9000244140625, "elevtn_dn": 874.0, "invlev_up": 883.4000244140625, "invlev_dn": 871.5, "manhole_up": "manhole_664_generated", "manhole_dn": "manhole_665_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388133.769964092643932, 5861774.101925062015653 ], [ 1388099.452548687811941, 5861810.13500545732677 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 874.0, "elevtn_dn": 874.0, "invlev_up": 871.5, "invlev_dn": 871.5, "manhole_up": "manhole_665_generated", "manhole_dn": "manhole_666_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388099.452548687811941, 5861810.13500545732677 ], [ 1388065.135133283212781, 5861846.16808585356921 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 874.0, "elevtn_dn": 862.20001220703125, "invlev_up": 871.5, "invlev_dn": 859.70001220703125, "manhole_up": "manhole_666_generated", "manhole_dn": "manhole_667_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388065.135133283212781, 5861846.16808585356921 ], [ 1388022.995196633273736, 5861866.899685021489859 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 862.20001220703125, "elevtn_dn": 862.20001220703125, "invlev_up": 859.70001220703125, "invlev_dn": 859.70001220703125, "manhole_up": "manhole_667_generated", "manhole_dn": "manhole_668_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388022.995196633273736, 5861866.899685021489859 ], [ 1387973.690499771386385, 5861873.616436487063766 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 862.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 859.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_668_generated", "manhole_dn": "manhole_669_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387973.690499771386385, 5861873.616436487063766 ], [ 1387924.470484273741022, 5861880.90659652557224 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_669_generated", "manhole_dn": "manhole_670_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387924.470484273741022, 5861880.90659652557224 ], [ 1387877.962616891367361, 5861896.157046243548393 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_670_generated", "manhole_dn": "manhole_671_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387877.962616891367361, 5861896.157046243548393 ], [ 1387917.070526217576116, 5861911.915829903446138 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_671_generated", "manhole_dn": "manhole_672_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387917.070526217576116, 5861911.915829903446138 ], [ 1387966.654667611001059, 5861916.096835186704993 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 846.29998779296875, "invlev_up": 856.70001220703125, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_672_generated", "manhole_dn": "manhole_673_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387966.654667611001059, 5861916.096835186704993 ], [ 1388016.318005530629307, 5861919.063731476664543 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 850.10003662109375, "invlev_up": 843.79998779296875, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_673_generated", "manhole_dn": "manhole_674_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388016.318005530629307, 5861919.063731476664543 ], [ 1388066.025120510486886, 5861921.359510923735797 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E48", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 850.10003662109375, "invlev_up": 847.60003662109375, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_674_generated", "manhole_dn": "manhole_675_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388066.025120510486886, 5861921.359510923735797 ], [ 1388115.732235490344465, 5861923.655290370807052 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E49", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 849.0, "invlev_up": 847.60003662109375, "invlev_dn": 846.5, "manhole_up": "manhole_675_generated", "manhole_dn": "manhole_676_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388115.732235490344465, 5861923.655290370807052 ], [ 1388161.130695321131498, 5861931.457672152668238 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E50", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 849.0, "elevtn_dn": 850.10003662109375, "invlev_up": 846.5, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_676_generated", "manhole_dn": "manhole_677_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388161.130695321131498, 5861931.457672152668238 ], [ 1388139.871223766123876, 5861964.082641129381955 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E51", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 850.10003662109375, "invlev_up": 847.60003662109375, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_677_generated", "manhole_dn": "manhole_678_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388139.871223766123876, 5861964.082641129381955 ], [ 1388090.726845995755866, 5861957.769498392008245 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E52", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 846.29998779296875, "invlev_up": 847.60003662109375, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_678_generated", "manhole_dn": "manhole_679_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388090.726845995755866, 5861957.769498392008245 ], [ 1388049.339104855433106, 5861983.736727176234126 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E53", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 846.29998779296875, "invlev_up": 843.79998779296875, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_679_generated", "manhole_dn": "manhole_680_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388049.339104855433106, 5861983.736727176234126 ], [ 1388024.713075590552762, 5862026.975905770435929 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E54", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 846.29998779296875, "invlev_up": 843.79998779296875, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_680_generated", "manhole_dn": "manhole_681_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388024.713075590552762, 5862026.975905770435929 ], [ 1387980.016218039905652, 5862047.702198376879096 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E55", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 793.5, "invlev_up": 843.79998779296875, "invlev_dn": 791.0, "manhole_up": "manhole_681_generated", "manhole_dn": "manhole_682_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387980.016218039905652, 5862047.702198376879096 ], [ 1387931.90673128189519, 5862056.853296543471515 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E56", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.5, "elevtn_dn": 793.5, "invlev_up": 791.0, "invlev_dn": 791.0, "manhole_up": "manhole_682_generated", "manhole_dn": "manhole_683_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387931.90673128189519, 5862056.853296543471515 ], [ 1387882.187313467729837, 5862058.865105460397899 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E57", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.5, "elevtn_dn": 793.20001220703125, "invlev_up": 791.0, "invlev_dn": 790.70001220703125, "manhole_up": "manhole_683_generated", "manhole_dn": "manhole_684_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387882.187313467729837, 5862058.865105460397899 ], [ 1387832.722497318405658, 5862057.3410848621279 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E58", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.20001220703125, "elevtn_dn": 830.29998779296875, "invlev_up": 790.70001220703125, "invlev_dn": 827.79998779296875, "manhole_up": "manhole_684_generated", "manhole_dn": "manhole_685_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387832.722497318405658, 5862057.3410848621279 ], [ 1387783.80423084856011, 5862048.226750630885363 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E59", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.29998779296875, "elevtn_dn": 817.70001220703125, "invlev_up": 827.79998779296875, "invlev_dn": 815.20001220703125, "manhole_up": "manhole_685_generated", "manhole_dn": "manhole_686_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387783.80423084856011, 5862048.226750630885363 ], [ 1387734.885964378714561, 5862039.112416399642825 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E60", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 817.70001220703125, "elevtn_dn": 813.70001220703125, "invlev_up": 815.20001220703125, "invlev_dn": 811.20001220703125, "manhole_up": "manhole_686_generated", "manhole_dn": "manhole_687_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387734.885964378714561, 5862039.112416399642825 ], [ 1387685.967697908869013, 5862029.998082168400288 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E61", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 813.70001220703125, "elevtn_dn": 813.70001220703125, "invlev_up": 811.20001220703125, "invlev_dn": 811.20001220703125, "manhole_up": "manhole_687_generated", "manhole_dn": "manhole_688_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387685.967697908869013, 5862029.998082168400288 ], [ 1387637.036115845199674, 5862020.957140567712486 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E62", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 813.70001220703125, "elevtn_dn": 807.0, "invlev_up": 811.20001220703125, "invlev_dn": 804.5, "manhole_up": "manhole_688_generated", "manhole_dn": "manhole_689_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387637.036115845199674, 5862020.957140567712486 ], [ 1387588.033849656581879, 5862012.305794355459511 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E63", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.0, "elevtn_dn": 807.0, "invlev_up": 804.5, "invlev_dn": 804.5, "manhole_up": "manhole_689_generated", "manhole_dn": "manhole_690_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387588.033849656581879, 5862012.305794355459511 ], [ 1387539.031583468196914, 5862003.654448143206537 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E64", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 807.0, "elevtn_dn": 793.10003662109375, "invlev_up": 804.5, "invlev_dn": 790.60003662109375, "manhole_up": "manhole_690_generated", "manhole_dn": "manhole_691_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387539.031583468196914, 5862003.654448143206537 ], [ 1387490.029317279579118, 5861995.003101930953562 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E65", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.10003662109375, "elevtn_dn": 793.10003662109375, "invlev_up": 790.60003662109375, "invlev_dn": 790.60003662109375, "manhole_up": "manhole_691_generated", "manhole_dn": "manhole_692_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387490.029317279579118, 5861995.003101930953562 ], [ 1387440.720367865404114, 5861989.908138634636998 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E66", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 793.10003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 790.60003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_692_generated", "manhole_dn": "manhole_693_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387440.720367865404114, 5861989.908138634636998 ], [ 1387390.960446665296331, 5861990.042768024839461 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E67", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_693_generated", "manhole_dn": "manhole_694_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387390.960446665296331, 5861990.042768024839461 ], [ 1387341.200525465421379, 5861990.177397414110601 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E68", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 749.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 747.10003662109375, "manhole_up": "manhole_694_generated", "manhole_dn": "manhole_695_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387341.200525465421379, 5861990.177397414110601 ], [ 1387291.440604265546426, 5861990.312026804313064 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E69", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 749.60003662109375, "elevtn_dn": 749.60003662109375, "invlev_up": 747.10003662109375, "invlev_dn": 747.10003662109375, "manhole_up": "manhole_695_generated", "manhole_dn": "manhole_696_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387291.440604265546426, 5861990.312026804313064 ], [ 1387246.706285298336297, 5861974.212805554270744 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E70", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 749.60003662109375, "elevtn_dn": 747.0, "invlev_up": 747.10003662109375, "invlev_dn": 744.5, "manhole_up": "manhole_696_generated", "manhole_dn": "manhole_697_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387246.706285298336297, 5861974.212805554270744 ], [ 1387205.725988702848554, 5861945.987228964455426 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E71", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.0, "elevtn_dn": 771.79998779296875, "invlev_up": 744.5, "invlev_dn": 769.29998779296875, "manhole_up": "manhole_697_generated", "manhole_dn": "manhole_698_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387205.725988702848554, 5861945.987228964455426 ], [ 1387164.745692107127979, 5861917.761652374640107 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E72", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 771.79998779296875, "elevtn_dn": 764.10003662109375, "invlev_up": 769.29998779296875, "invlev_dn": 761.60003662109375, "manhole_up": "manhole_698_generated", "manhole_dn": "manhole_699_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387164.745692107127979, 5861917.761652374640107 ], [ 1387115.569933785125613, 5861911.215812381356955 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E73", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.10003662109375, "elevtn_dn": 764.10003662109375, "invlev_up": 761.60003662109375, "invlev_dn": 761.60003662109375, "manhole_up": "manhole_699_generated", "manhole_dn": "manhole_700_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387115.569933785125613, 5861911.215812381356955 ], [ 1387066.165866439929232, 5861905.273926095105708 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E74", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.10003662109375, "elevtn_dn": 747.70001220703125, "invlev_up": 761.60003662109375, "invlev_dn": 745.20001220703125, "manhole_up": "manhole_700_generated", "manhole_dn": "manhole_701_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387066.165866439929232, 5861905.273926095105708 ], [ 1387016.666836149292067, 5861900.238133460283279 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E75", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.70001220703125, "elevtn_dn": 747.70001220703125, "invlev_up": 745.20001220703125, "invlev_dn": 745.20001220703125, "manhole_up": "manhole_701_generated", "manhole_dn": "manhole_702_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387016.666836149292067, 5861900.238133460283279 ], [ 1386975.698310127714649, 5861874.842493440955877 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E76", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 747.70001220703125, "elevtn_dn": 739.60003662109375, "invlev_up": 745.20001220703125, "invlev_dn": 737.10003662109375, "manhole_up": "manhole_702_generated", "manhole_dn": "manhole_703_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386975.698310127714649, 5861874.842493440955877 ], [ 1386937.286019780673087, 5861843.21080310922116 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E77", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.60003662109375, "elevtn_dn": 739.60003662109375, "invlev_up": 737.10003662109375, "invlev_dn": 737.10003662109375, "manhole_up": "manhole_703_generated", "manhole_dn": "manhole_704_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386937.286019780673087, 5861843.21080310922116 ], [ 1386898.873729433864355, 5861811.579112778417766 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E78", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 739.60003662109375, "elevtn_dn": 755.20001220703125, "invlev_up": 737.10003662109375, "invlev_dn": 752.70001220703125, "manhole_up": "manhole_704_generated", "manhole_dn": "manhole_705_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386898.873729433864355, 5861811.579112778417766 ], [ 1386860.461439087055624, 5861779.947422447614372 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E79", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 755.20001220703125, "elevtn_dn": 745.29998779296875, "invlev_up": 752.70001220703125, "invlev_dn": 742.79998779296875, "manhole_up": "manhole_705_generated", "manhole_dn": "manhole_706_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386860.461439087055624, 5861779.947422447614372 ], [ 1386822.049148740014061, 5861748.315732115879655 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E80", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 745.29998779296875, "elevtn_dn": 745.29998779296875, "invlev_up": 742.79998779296875, "invlev_dn": 742.79998779296875, "manhole_up": "manhole_706_generated", "manhole_dn": "manhole_707_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386822.049148740014061, 5861748.315732115879655 ], [ 1386774.418702265014872, 5861733.958941764198244 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E81", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 745.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 742.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_707_generated", "manhole_dn": "manhole_708_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386774.418702265014872, 5861733.958941764198244 ], [ 1386726.75721522886306, 5861719.660321676172316 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E82", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_708_generated", "manhole_dn": "manhole_709_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386726.75721522886306, 5861719.660321676172316 ], [ 1386681.211287560872734, 5861700.510515534318984 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E83", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 777.9000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_709_generated", "manhole_dn": "manhole_710_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386681.211287560872734, 5861700.510515534318984 ], [ 1386655.081909105414525, 5861659.807657876051962 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E84", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 758.79998779296875, "invlev_up": 775.4000244140625, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_710_generated", "manhole_dn": "manhole_711_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386655.081909105414525, 5861659.807657876051962 ], [ 1386647.41175345890224, 5861610.757949161343277 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E85", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_711_generated", "manhole_dn": "manhole_712_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386647.41175345890224, 5861610.757949161343277 ], [ 1386641.745189253240824, 5861561.363539570011199 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E86", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 732.4000244140625, "invlev_up": 756.29998779296875, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_712_generated", "manhole_dn": "manhole_713_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386641.745189253240824, 5861561.363539570011199 ], [ 1386642.37134926696308, 5861511.607376066967845 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E87", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_713_generated", "manhole_dn": "manhole_714_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386642.37134926696308, 5861511.607376066967845 ], [ 1386642.997509280918166, 5861461.851212563924491 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E88", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_714_generated", "manhole_dn": "manhole_715_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386642.997509280918166, 5861461.851212563924491 ], [ 1386643.623669294640422, 5861412.09504906181246 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_34_E89", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_34", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 724.29998779296875, "invlev_up": 729.9000244140625, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_715_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386643.623669294640422, 5861412.09504906181246 ], [ 1386648.271799877518788, 5861347.644815167412162 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_35_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_35", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_35", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_716_generated", "manhole_dn": "manhole_717_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386060.978602184914052, 5859873.390328846871853 ], [ 1386078.54455375042744, 5859857.065600479952991 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_35_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_35", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_35", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_717_generated", "manhole_dn": "manhole_718_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386078.54455375042744, 5859857.065600479952991 ], [ 1386079.86695942771621, 5859885.500408614054322 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_36_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_36", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_36", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_719_generated", "manhole_dn": "manhole_716_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386030.926458492642269, 5859869.881591100245714 ], [ 1386060.978602184914052, 5859873.390328846871853 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_37_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_37", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_37", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_720_generated", "manhole_dn": "manhole_716_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386043.381105761509389, 5859908.11929196305573 ], [ 1386060.978602184914052, 5859873.390328846871853 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_38_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_38", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_718_generated", "manhole_dn": "manhole_721_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386079.86695942771621, 5859885.500408614054322 ], [ 1386081.40363402524963, 5859934.756705570034683 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_38_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_38", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_721_generated", "manhole_dn": "manhole_722_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386081.40363402524963, 5859934.756705570034683 ], [ 1386080.471781946951523, 5859983.948014200665057 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_38_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_38", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 756.5, "invlev_up": 763.79998779296875, "invlev_dn": 754.0, "manhole_up": "manhole_722_generated", "manhole_dn": "manhole_723_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386080.471781946951523, 5859983.948014200665057 ], [ 1386081.101269942475483, 5860033.01989212166518 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_39_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_39", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_718_generated", "manhole_dn": "manhole_724_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386079.86695942771621, 5859885.500408614054322 ], [ 1386051.415038994979113, 5859913.714703594334424 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_39_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_39", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_724_generated", "manhole_dn": "manhole_725_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386051.415038994979113, 5859913.714703594334424 ], [ 1386056.753747603856027, 5859949.43277302198112 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_39_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_39", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_725_generated", "manhole_dn": "manhole_726_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386056.753747603856027, 5859949.43277302198112 ], [ 1386070.153564189793542, 5859990.873222404159606 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_39_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_39", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 756.5, "invlev_up": 763.79998779296875, "invlev_dn": 754.0, "manhole_up": "manhole_726_generated", "manhole_dn": "manhole_723_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386070.153564189793542, 5859990.873222404159606 ], [ 1386081.101269942475483, 5860033.01989212166518 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.5, "elevtn_dn": 756.5, "invlev_up": 754.0, "invlev_dn": 754.0, "manhole_up": "manhole_723_generated", "manhole_dn": "manhole_727_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386081.101269942475483, 5860033.01989212166518 ], [ 1386095.159510504920036, 5860079.476792480796576 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.5, "elevtn_dn": 720.29998779296875, "invlev_up": 754.0, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_727_generated", "manhole_dn": "manhole_728_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386095.159510504920036, 5860079.476792480796576 ], [ 1386119.249574675457552, 5860122.285581497475505 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_728_generated", "manhole_dn": "manhole_729_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386119.249574675457552, 5860122.285581497475505 ], [ 1386143.813145637512207, 5860164.822058788500726 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 732.5, "invlev_up": 717.79998779296875, "invlev_dn": 730.0, "manhole_up": "manhole_729_generated", "manhole_dn": "manhole_730_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386143.813145637512207, 5860164.822058788500726 ], [ 1386168.698389830067754, 5860207.173543182201684 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.5, "elevtn_dn": 732.5, "invlev_up": 730.0, "invlev_dn": 730.0, "manhole_up": "manhole_730_generated", "manhole_dn": "manhole_731_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386168.698389830067754, 5860207.173543182201684 ], [ 1386190.960878706537187, 5860250.914158629253507 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.5, "elevtn_dn": 720.29998779296875, "invlev_up": 730.0, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_731_generated", "manhole_dn": "manhole_732_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386190.960878706537187, 5860250.914158629253507 ], [ 1386212.013376480899751, 5860295.295640649273992 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 729.10003662109375, "invlev_up": 717.79998779296875, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_732_generated", "manhole_dn": "manhole_733_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386212.013376480899751, 5860295.295640649273992 ], [ 1386233.065874255495146, 5860339.677122670225799 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 729.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_733_generated", "manhole_dn": "manhole_734_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386233.065874255495146, 5860339.677122670225799 ], [ 1386254.118372030090541, 5860384.058604690246284 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 729.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_734_generated", "manhole_dn": "manhole_735_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386254.118372030090541, 5860384.058604690246284 ], [ 1386270.265550139825791, 5860430.368606903590262 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 746.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 743.60003662109375, "manhole_up": "manhole_735_generated", "manhole_dn": "manhole_736_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386270.265550139825791, 5860430.368606903590262 ], [ 1386284.690116602927446, 5860477.310510716401041 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 746.10003662109375, "elevtn_dn": 746.10003662109375, "invlev_up": 743.60003662109375, "invlev_dn": 743.60003662109375, "manhole_up": "manhole_736_generated", "manhole_dn": "manhole_737_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386284.690116602927446, 5860477.310510716401041 ], [ 1386295.943752367515117, 5860525.125563691370189 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 746.10003662109375, "elevtn_dn": 720.29998779296875, "invlev_up": 743.60003662109375, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_737_generated", "manhole_dn": "manhole_738_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386295.943752367515117, 5860525.125563691370189 ], [ 1386307.197388132335618, 5860572.940616665408015 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_738_generated", "manhole_dn": "manhole_739_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386307.197388132335618, 5860572.940616665408015 ], [ 1386318.451023896923289, 5860620.755669640377164 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_739_generated", "manhole_dn": "manhole_740_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386318.451023896923289, 5860620.755669640377164 ], [ 1386329.704659661510959, 5860668.57072261441499 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 737.60003662109375, "invlev_up": 717.79998779296875, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_740_generated", "manhole_dn": "manhole_741_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386329.704659661510959, 5860668.57072261441499 ], [ 1386340.95829542633146, 5860716.385775589384139 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 737.60003662109375, "invlev_up": 735.10003662109375, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_741_generated", "manhole_dn": "manhole_742_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386340.95829542633146, 5860716.385775589384139 ], [ 1386352.211931190919131, 5860764.200828563421965 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 737.60003662109375, "invlev_up": 735.10003662109375, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_742_generated", "manhole_dn": "manhole_743_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386352.211931190919131, 5860764.200828563421965 ], [ 1386365.771370212780312, 5860811.365820310078561 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 744.5, "invlev_up": 735.10003662109375, "invlev_dn": 742.0, "manhole_up": "manhole_743_generated", "manhole_dn": "manhole_744_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386365.771370212780312, 5860811.365820310078561 ], [ 1386381.150273493025452, 5860858.017861452884972 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 744.5, "elevtn_dn": 724.29998779296875, "invlev_up": 742.0, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_744_generated", "manhole_dn": "manhole_745_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386381.150273493025452, 5860858.017861452884972 ], [ 1386398.399082327727228, 5860903.951519219204783 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_745_generated", "manhole_dn": "manhole_746_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386398.399082327727228, 5860903.951519219204783 ], [ 1386418.211523674428463, 5860948.90027645137161 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_746_generated", "manhole_dn": "manhole_747_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386418.211523674428463, 5860948.90027645137161 ], [ 1386441.67837643600069, 5860992.033180211670697 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_747_generated", "manhole_dn": "manhole_748_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386441.67837643600069, 5860992.033180211670697 ], [ 1386465.536530936835334, 5861034.971648660488427 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.9000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 722.4000244140625, "manhole_up": "manhole_748_generated", "manhole_dn": "manhole_749_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386465.536530936835334, 5861034.971648660488427 ], [ 1386489.394685437437147, 5861077.910117109306157 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.9000244140625, "elevtn_dn": 724.29998779296875, "invlev_up": 722.4000244140625, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_749_generated", "manhole_dn": "manhole_750_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386489.394685437437147, 5861077.910117109306157 ], [ 1386513.252839938271791, 5861120.848585557192564 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_750_generated", "manhole_dn": "manhole_751_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386513.252839938271791, 5861120.848585557192564 ], [ 1386537.110994438873604, 5861163.787054006010294 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_751_generated", "manhole_dn": "manhole_752_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386537.110994438873604, 5861163.787054006010294 ], [ 1386560.969148939708248, 5861206.725522454828024 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_752_generated", "manhole_dn": "manhole_753_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386560.969148939708248, 5861206.725522454828024 ], [ 1386584.827303440310061, 5861249.663990902714431 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_753_generated", "manhole_dn": "manhole_754_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386584.827303440310061, 5861249.663990902714431 ], [ 1386607.696082097478211, 5861293.105181481689215 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_754_generated", "manhole_dn": "manhole_755_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386607.696082097478211, 5861293.105181481689215 ], [ 1386626.999141034670174, 5861338.164890616200864 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 732.4000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_755_generated", "manhole_dn": "manhole_756_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386626.999141034670174, 5861338.164890616200864 ], [ 1386632.635544582502916, 5861386.242180755361915 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_756_generated", "manhole_dn": "manhole_757_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386632.635544582502916, 5861386.242180755361915 ], [ 1386628.332881111185998, 5861435.174896763637662 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_757_generated", "manhole_dn": "manhole_758_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386628.332881111185998, 5861435.174896763637662 ], [ 1386624.030217639869079, 5861484.107612771913409 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 758.79998779296875, "invlev_up": 729.9000244140625, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_758_generated", "manhole_dn": "manhole_759_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386624.030217639869079, 5861484.107612771913409 ], [ 1386619.72755416855216, 5861533.040328779257834 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_759_generated", "manhole_dn": "manhole_760_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386619.72755416855216, 5861533.040328779257834 ], [ 1386620.396809899713844, 5861581.843449912965298 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_760_generated", "manhole_dn": "manhole_761_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386620.396809899713844, 5861581.843449912965298 ], [ 1386627.242796876933426, 5861630.485572309233248 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 777.9000244140625, "invlev_up": 756.29998779296875, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_761_generated", "manhole_dn": "manhole_762_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386627.242796876933426, 5861630.485572309233248 ], [ 1386633.497009602142498, 5861679.177458625286818 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 777.9000244140625, "invlev_up": 775.4000244140625, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_762_generated", "manhole_dn": "manhole_763_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386633.497009602142498, 5861679.177458625286818 ], [ 1386633.587326586712152, 5861728.232037586160004 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 777.9000244140625, "invlev_up": 775.4000244140625, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_763_generated", "manhole_dn": "manhole_764_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386633.587326586712152, 5861728.232037586160004 ], [ 1386628.569951781770214, 5861777.096641942858696 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_40_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_40", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 787.0, "invlev_up": 775.4000244140625, "invlev_dn": 784.5, "manhole_up": "manhole_764_generated", "manhole_dn": "manhole_765_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386628.569951781770214, 5861777.096641942858696 ], [ 1386623.552576976828277, 5861825.961246299557388 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.0, "elevtn_dn": 787.0, "invlev_up": 784.5, "invlev_dn": 784.5, "manhole_up": "manhole_765_generated", "manhole_dn": "manhole_766_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386623.552576976828277, 5861825.961246299557388 ], [ 1386622.452884682221338, 5861875.377415779046714 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 787.0, "elevtn_dn": 768.0, "invlev_up": 784.5, "invlev_dn": 765.5, "manhole_up": "manhole_766_generated", "manhole_dn": "manhole_767_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386622.452884682221338, 5861875.377415779046714 ], [ 1386630.050831846194342, 5861924.208797036670148 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_767_generated", "manhole_dn": "manhole_768_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386630.050831846194342, 5861924.208797036670148 ], [ 1386645.112437101313844, 5861971.295391816645861 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_768_generated", "manhole_dn": "manhole_769_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386645.112437101313844, 5861971.295391816645861 ], [ 1386663.826805545249954, 5862017.116109635680914 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 729.0, "invlev_up": 765.5, "invlev_dn": 726.5, "manhole_up": "manhole_769_generated", "manhole_dn": "manhole_770_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386663.826805545249954, 5862017.116109635680914 ], [ 1386682.541173989186063, 5862062.93682745564729 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 729.0, "invlev_up": 726.5, "invlev_dn": 726.5, "manhole_up": "manhole_770_generated", "manhole_dn": "manhole_771_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386682.541173989186063, 5862062.93682745564729 ], [ 1386700.357504795538262, 5862109.113540357910097 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 729.0, "invlev_up": 726.5, "invlev_dn": 726.5, "manhole_up": "manhole_771_generated", "manhole_dn": "manhole_772_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386700.357504795538262, 5862109.113540357910097 ], [ 1386718.120609947945923, 5862155.311352676711977 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 724.29998779296875, "invlev_up": 726.5, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_772_generated", "manhole_dn": "manhole_773_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386718.120609947945923, 5862155.311352676711977 ], [ 1386735.883715100120753, 5862201.509164996445179 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_773_generated", "manhole_dn": "manhole_774_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386735.883715100120753, 5862201.509164996445179 ], [ 1386757.522535112220794, 5862245.993861058726907 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_774_generated", "manhole_dn": "manhole_775_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386757.522535112220794, 5862245.993861058726907 ], [ 1386779.73098383564502, 5862290.226773838512599 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_775_generated", "manhole_dn": "manhole_776_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386779.73098383564502, 5862290.226773838512599 ], [ 1386802.545179207576439, 5862334.095372994430363 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_776_generated", "manhole_dn": "manhole_777_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386802.545179207576439, 5862334.095372994430363 ], [ 1386831.207993831252679, 5862374.446442689746618 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 737.70001220703125, "invlev_up": 721.79998779296875, "invlev_dn": 735.20001220703125, "manhole_up": "manhole_777_generated", "manhole_dn": "manhole_778_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386831.207993831252679, 5862374.446442689746618 ], [ 1386859.988485741894692, 5862414.708453865721822 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E13", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.70001220703125, "elevtn_dn": 737.70001220703125, "invlev_up": 735.20001220703125, "invlev_dn": 735.20001220703125, "manhole_up": "manhole_778_generated", "manhole_dn": "manhole_779_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386859.988485741894692, 5862414.708453865721822 ], [ 1386891.035651177866384, 5862453.255039785988629 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E14", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 737.70001220703125, "elevtn_dn": 743.9000244140625, "invlev_up": 735.20001220703125, "invlev_dn": 741.4000244140625, "manhole_up": "manhole_779_generated", "manhole_dn": "manhole_780_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386891.035651177866384, 5862453.255039785988629 ], [ 1386922.082816614070907, 5862491.801625707186759 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E15", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 743.9000244140625, "elevtn_dn": 756.0, "invlev_up": 741.4000244140625, "invlev_dn": 753.5, "manhole_up": "manhole_780_generated", "manhole_dn": "manhole_781_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386922.082816614070907, 5862491.801625707186759 ], [ 1386953.12998205027543, 5862530.348211627453566 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E16", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.0, "elevtn_dn": 756.0, "invlev_up": 753.5, "invlev_dn": 753.5, "manhole_up": "manhole_781_generated", "manhole_dn": "manhole_782_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386953.12998205027543, 5862530.348211627453566 ], [ 1386984.177147486479953, 5862568.894797547720373 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E17", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 756.0, "elevtn_dn": 761.4000244140625, "invlev_up": 753.5, "invlev_dn": 758.9000244140625, "manhole_up": "manhole_782_generated", "manhole_dn": "manhole_783_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386984.177147486479953, 5862568.894797547720373 ], [ 1387010.83190148579888, 5862610.297833287157118 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E18", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.4000244140625, "elevtn_dn": 761.4000244140625, "invlev_up": 758.9000244140625, "invlev_dn": 758.9000244140625, "manhole_up": "manhole_783_generated", "manhole_dn": "manhole_784_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387010.83190148579888, 5862610.297833287157118 ], [ 1387033.474099110113457, 5862654.310293504968286 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E19", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 761.4000244140625, "elevtn_dn": 770.5, "invlev_up": 758.9000244140625, "invlev_dn": 768.0, "manhole_up": "manhole_784_generated", "manhole_dn": "manhole_785_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387033.474099110113457, 5862654.310293504968286 ], [ 1387056.116296734428033, 5862698.322753723710775 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E20", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 770.5, "elevtn_dn": 765.29998779296875, "invlev_up": 768.0, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_785_generated", "manhole_dn": "manhole_786_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387056.116296734428033, 5862698.322753723710775 ], [ 1387078.75849435874261, 5862742.335213942453265 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E21", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 765.29998779296875, "invlev_up": 762.79998779296875, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_786_generated", "manhole_dn": "manhole_787_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387078.75849435874261, 5862742.335213942453265 ], [ 1387101.400691983057186, 5862786.347674161195755 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E22", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 765.29998779296875, "invlev_up": 762.79998779296875, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_787_generated", "manhole_dn": "manhole_788_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387101.400691983057186, 5862786.347674161195755 ], [ 1387124.783531384309754, 5862829.966971693560481 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E23", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 764.20001220703125, "invlev_up": 762.79998779296875, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_788_generated", "manhole_dn": "manhole_789_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387124.783531384309754, 5862829.966971693560481 ], [ 1387148.551342260092497, 5862873.381910757161677 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E24", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 764.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_789_generated", "manhole_dn": "manhole_790_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387148.551342260092497, 5862873.381910757161677 ], [ 1387176.029596295906231, 5862914.516764627769589 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E25", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 764.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_790_generated", "manhole_dn": "manhole_791_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387176.029596295906231, 5862914.516764627769589 ], [ 1387204.050833505578339, 5862955.315435893833637 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E26", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 769.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 766.70001220703125, "manhole_up": "manhole_791_generated", "manhole_dn": "manhole_792_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387204.050833505578339, 5862955.315435893833637 ], [ 1387233.152246462181211, 5862995.351338926702738 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E27", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 769.20001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 766.70001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_792_generated", "manhole_dn": "manhole_793_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387233.152246462181211, 5862995.351338926702738 ], [ 1387262.253659419016913, 5863035.387241959571838 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E28", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 770.20001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_793_generated", "manhole_dn": "manhole_794_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387262.253659419016913, 5863035.387241959571838 ], [ 1387289.177211825968698, 5863076.714860137552023 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E29", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 770.20001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_794_generated", "manhole_dn": "manhole_795_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387289.177211825968698, 5863076.714860137552023 ], [ 1387304.666786204557866, 5863123.392671256326139 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E30", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 762.0, "invlev_up": 770.20001220703125, "invlev_dn": 759.5, "manhole_up": "manhole_795_generated", "manhole_dn": "manhole_796_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387304.666786204557866, 5863123.392671256326139 ], [ 1387314.520281337434426, 5863171.895173518918455 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E31", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 777.10003662109375, "invlev_up": 759.5, "invlev_dn": 774.60003662109375, "manhole_up": "manhole_796_generated", "manhole_dn": "manhole_797_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387314.520281337434426, 5863171.895173518918455 ], [ 1387324.142220750683919, 5863220.446013364940882 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E32", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.10003662109375, "elevtn_dn": 780.4000244140625, "invlev_up": 774.60003662109375, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_797_generated", "manhole_dn": "manhole_798_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387324.142220750683919, 5863220.446013364940882 ], [ 1387333.764160163700581, 5863268.996853210031986 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E33", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 780.4000244140625, "invlev_up": 777.9000244140625, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_798_generated", "manhole_dn": "manhole_799_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387333.764160163700581, 5863268.996853210031986 ], [ 1387343.386099576717243, 5863317.547693055123091 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E34", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 780.4000244140625, "invlev_up": 777.9000244140625, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_799_generated", "manhole_dn": "manhole_800_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387343.386099576717243, 5863317.547693055123091 ], [ 1387353.008038989733905, 5863366.098532900214195 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E35", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 762.0, "invlev_up": 777.9000244140625, "invlev_dn": 759.5, "manhole_up": "manhole_800_generated", "manhole_dn": "manhole_801_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387353.008038989733905, 5863366.098532900214195 ], [ 1387364.066297837067395, 5863414.311534740030766 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E36", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_801_generated", "manhole_dn": "manhole_802_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387364.066297837067395, 5863414.311534740030766 ], [ 1387381.839409928303212, 5863460.427046488039196 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E37", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_802_generated", "manhole_dn": "manhole_803_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387381.839409928303212, 5863460.427046488039196 ], [ 1387403.429578960640356, 5863504.96100580971688 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E38", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_803_generated", "manhole_dn": "manhole_804_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387403.429578960640356, 5863504.96100580971688 ], [ 1387425.140452897874638, 5863549.440256260335445 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E39", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_804_generated", "manhole_dn": "manhole_805_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387425.140452897874638, 5863549.440256260335445 ], [ 1387446.851326835108921, 5863593.91950671095401 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E40", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_805_generated", "manhole_dn": "manhole_806_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387446.851326835108921, 5863593.91950671095401 ], [ 1387467.528695637593046, 5863638.888379830867052 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E41", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 774.5, "invlev_up": 759.5, "invlev_dn": 772.0, "manhole_up": "manhole_806_generated", "manhole_dn": "manhole_807_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387467.528695637593046, 5863638.888379830867052 ], [ 1387488.196078018052503, 5863683.861984014511108 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E42", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.5, "elevtn_dn": 762.0, "invlev_up": 772.0, "invlev_dn": 759.5, "manhole_up": "manhole_807_generated", "manhole_dn": "manhole_808_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387488.196078018052503, 5863683.861984014511108 ], [ 1387508.863468252588063, 5863728.835584589280188 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E43", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_808_generated", "manhole_dn": "manhole_809_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387508.863468252588063, 5863728.835584589280188 ], [ 1387529.53130904212594, 5863773.808978110551834 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E44", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_809_generated", "manhole_dn": "manhole_810_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387529.53130904212594, 5863773.808978110551834 ], [ 1387553.168002701364458, 5863817.17347530182451 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E45", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_810_generated", "manhole_dn": "manhole_811_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387553.168002701364458, 5863817.17347530182451 ], [ 1387579.562712850514799, 5863859.043333718553185 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E46", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 777.0, "invlev_up": 759.5, "invlev_dn": 774.5, "manhole_up": "manhole_811_generated", "manhole_dn": "manhole_812_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387579.562712850514799, 5863859.043333718553185 ], [ 1387605.957422999665141, 5863900.913192136213183 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E47", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.0, "elevtn_dn": 762.0, "invlev_up": 774.5, "invlev_dn": 759.5, "manhole_up": "manhole_812_generated", "manhole_dn": "manhole_813_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387605.957422999665141, 5863900.913192136213183 ], [ 1387632.352133149048313, 5863942.783050553873181 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E48", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_813_generated", "manhole_dn": "manhole_814_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387632.352133149048313, 5863942.783050553873181 ], [ 1387658.746843298198655, 5863984.652908970601857 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E49", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_814_generated", "manhole_dn": "manhole_815_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387658.746843298198655, 5863984.652908970601857 ], [ 1387685.893106181640178, 5864026.029537551105022 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E50", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_815_generated", "manhole_dn": "manhole_816_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387685.893106181640178, 5864026.029537551105022 ], [ 1387711.231136992340907, 5864068.42725711222738 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E51", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_816_generated", "manhole_dn": "manhole_817_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387711.231136992340907, 5864068.42725711222738 ], [ 1387731.020947323646396, 5864113.414904261007905 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E52", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_817_generated", "manhole_dn": "manhole_818_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387731.020947323646396, 5864113.414904261007905 ], [ 1387737.361907477490604, 5864162.342261835932732 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E53", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_818_generated", "manhole_dn": "manhole_819_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387737.361907477490604, 5864162.342261835932732 ], [ 1387732.727565656881779, 5864211.475179814733565 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E54", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_819_generated", "manhole_dn": "manhole_820_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387732.727565656881779, 5864211.475179814733565 ], [ 1387717.67884943424724, 5864258.627082298509777 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E55", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_820_generated", "manhole_dn": "manhole_821_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387717.67884943424724, 5864258.627082298509777 ], [ 1387709.67210421175696, 5864307.23127611912787 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E56", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 768.0, "invlev_up": 759.5, "invlev_dn": 765.5, "manhole_up": "manhole_821_generated", "manhole_dn": "manhole_822_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387709.67210421175696, 5864307.23127611912787 ], [ 1387707.11288084089756, 5864356.66017600055784 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E57", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_822_generated", "manhole_dn": "manhole_823_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387707.11288084089756, 5864356.66017600055784 ], [ 1387709.591797993984073, 5864406.012949175201356 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E58", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_823_generated", "manhole_dn": "manhole_824_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387709.591797993984073, 5864406.012949175201356 ], [ 1387713.643261310644448, 5864455.341961052268744 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E59", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 777.20001220703125, "invlev_up": 765.5, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_824_generated", "manhole_dn": "manhole_825_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387713.643261310644448, 5864455.341961052268744 ], [ 1387715.877521668095142, 5864504.642317942343652 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E60", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 774.70001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_825_generated", "manhole_dn": "manhole_826_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387715.877521668095142, 5864504.642317942343652 ], [ 1387708.68023270717822, 5864553.426558391191065 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E61", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 774.70001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_826_generated", "manhole_dn": "manhole_827_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387708.68023270717822, 5864553.426558391191065 ], [ 1387690.790250770282, 5864599.575386263430119 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E62", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 810.60003662109375, "invlev_up": 774.70001220703125, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_827_generated", "manhole_dn": "manhole_828_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387690.790250770282, 5864599.575386263430119 ], [ 1387672.900268833618611, 5864645.724214136600494 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E63", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 810.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_828_generated", "manhole_dn": "manhole_829_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387672.900268833618611, 5864645.724214136600494 ], [ 1387659.931900478899479, 5864692.98388583958149 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E64", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 810.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_829_generated", "manhole_dn": "manhole_830_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387659.931900478899479, 5864692.98388583958149 ], [ 1387659.223570322152227, 5864742.029465307481587 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E65", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_830_generated", "manhole_dn": "manhole_831_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387659.223570322152227, 5864742.029465307481587 ], [ 1387675.926896508783102, 5864788.273513910360634 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E66", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 774.10003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 771.60003662109375, "manhole_up": "manhole_831_generated", "manhole_dn": "manhole_832_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387675.926896508783102, 5864788.273513910360634 ], [ 1387702.296291569946334, 5864830.159320239908993 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E67", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.10003662109375, "elevtn_dn": 774.10003662109375, "invlev_up": 771.60003662109375, "invlev_dn": 771.60003662109375, "manhole_up": "manhole_832_generated", "manhole_dn": "manhole_833_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387702.296291569946334, 5864830.159320239908993 ], [ 1387728.665686630876735, 5864872.045126569457352 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E68", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 774.10003662109375, "elevtn_dn": 782.5, "invlev_up": 771.60003662109375, "invlev_dn": 780.0, "manhole_up": "manhole_833_generated", "manhole_dn": "manhole_834_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387728.665686630876735, 5864872.045126569457352 ], [ 1387751.608185108983889, 5864915.528788692317903 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E69", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 782.5, "invlev_up": 780.0, "invlev_dn": 780.0, "manhole_up": "manhole_834_generated", "manhole_dn": "manhole_835_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387751.608185108983889, 5864915.528788692317903 ], [ 1387766.741664502769709, 5864962.653554677963257 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E70", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 782.5, "invlev_up": 780.0, "invlev_dn": 780.0, "manhole_up": "manhole_835_generated", "manhole_dn": "manhole_836_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387766.741664502769709, 5864962.653554677963257 ], [ 1387778.99191950308159, 5865010.246724016033113 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E71", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 820.20001220703125, "invlev_up": 780.0, "invlev_dn": 817.70001220703125, "manhole_up": "manhole_836_generated", "manhole_dn": "manhole_837_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387778.99191950308159, 5865010.246724016033113 ], [ 1387779.554608268430457, 5865059.738633952103555 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E72", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.20001220703125, "elevtn_dn": 820.20001220703125, "invlev_up": 817.70001220703125, "invlev_dn": 817.70001220703125, "manhole_up": "manhole_837_generated", "manhole_dn": "manhole_838_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387779.554608268430457, 5865059.738633952103555 ], [ 1387780.117297033779323, 5865109.230543887242675 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E73", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 820.20001220703125, "elevtn_dn": 834.60003662109375, "invlev_up": 817.70001220703125, "invlev_dn": 832.10003662109375, "manhole_up": "manhole_838_generated", "manhole_dn": "manhole_839_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387780.117297033779323, 5865109.230543887242675 ], [ 1387782.917817069217563, 5865158.566991245374084 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E74", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 834.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 832.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_839_generated", "manhole_dn": "manhole_840_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387782.917817069217563, 5865158.566991245374084 ], [ 1387789.203931836877018, 5865207.661293652839959 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E75", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_840_generated", "manhole_dn": "manhole_841_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387789.203931836877018, 5865207.661293652839959 ], [ 1387795.490046604769304, 5865256.755596060305834 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E76", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_841_generated", "manhole_dn": "manhole_842_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387795.490046604769304, 5865256.755596060305834 ], [ 1387804.549934879876673, 5865305.332479531876743 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E77", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 809.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_842_generated", "manhole_dn": "manhole_843_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387804.549934879876673, 5865305.332479531876743 ], [ 1387816.386747075244784, 5865353.391356389038265 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E78", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 809.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_843_generated", "manhole_dn": "manhole_844_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387816.386747075244784, 5865353.391356389038265 ], [ 1387828.223559270845726, 5865401.450233246199787 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E79", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 802.5, "invlev_up": 809.10003662109375, "invlev_dn": 800.0, "manhole_up": "manhole_844_generated", "manhole_dn": "manhole_845_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387828.223559270845726, 5865401.450233246199787 ], [ 1387842.96627543354407, 5865448.679594250395894 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E80", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 802.5, "invlev_up": 800.0, "invlev_dn": 800.0, "manhole_up": "manhole_845_generated", "manhole_dn": "manhole_846_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387842.96627543354407, 5865448.679594250395894 ], [ 1387858.283513206522912, 5865495.744953005574644 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E81", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 802.5, "invlev_up": 800.0, "invlev_dn": 800.0, "manhole_up": "manhole_846_generated", "manhole_dn": "manhole_847_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387858.283513206522912, 5865495.744953005574644 ], [ 1387872.788357679266483, 5865543.026506381109357 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E82", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 778.20001220703125, "invlev_up": 800.0, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_847_generated", "manhole_dn": "manhole_848_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387872.788357679266483, 5865543.026506381109357 ], [ 1387882.890574953285977, 5865591.479689701460302 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E83", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_848_generated", "manhole_dn": "manhole_849_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387882.890574953285977, 5865591.479689701460302 ], [ 1387892.992792227305472, 5865639.932873022742569 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E84", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_849_generated", "manhole_dn": "manhole_850_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387892.992792227305472, 5865639.932873022742569 ], [ 1387903.095009501324967, 5865688.386056343093514 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_41_E85", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_41", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_850_generated", "manhole_dn": "manhole_851_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387903.095009501324967, 5865688.386056343093514 ], [ 1387913.197226775344461, 5865736.839239663444459 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 830.9000244140625, "invlev_up": 828.4000244140625, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_852_generated", "manhole_dn": "manhole_853_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387767.438602478476241, 5866395.894650792703032 ], [ 1387758.181959156645462, 5866444.388786932453513 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 830.9000244140625, "invlev_up": 828.4000244140625, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_853_generated", "manhole_dn": "manhole_854_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387758.181959156645462, 5866444.388786932453513 ], [ 1387748.925315835047513, 5866492.882923071272671 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 816.5, "invlev_up": 828.4000244140625, "invlev_dn": 814.0, "manhole_up": "manhole_854_generated", "manhole_dn": "manhole_855_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387748.925315835047513, 5866492.882923071272671 ], [ 1387739.668672513216734, 5866541.377059211023152 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.5, "elevtn_dn": 816.5, "invlev_up": 814.0, "invlev_dn": 814.0, "manhole_up": "manhole_855_generated", "manhole_dn": "manhole_856_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387739.668672513216734, 5866541.377059211023152 ], [ 1387730.412029191618785, 5866589.87119534984231 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.5, "elevtn_dn": 816.10003662109375, "invlev_up": 814.0, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_856_generated", "manhole_dn": "manhole_857_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387730.412029191618785, 5866589.87119534984231 ], [ 1387721.155385869788006, 5866638.365331489592791 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 816.10003662109375, "invlev_up": 813.60003662109375, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_857_generated", "manhole_dn": "manhole_858_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387721.155385869788006, 5866638.365331489592791 ], [ 1387711.868742506252602, 5866686.853722332976758 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 816.10003662109375, "invlev_up": 813.60003662109375, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_858_generated", "manhole_dn": "manhole_859_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387711.868742506252602, 5866686.853722332976758 ], [ 1387702.553355348296463, 5866735.336608462966979 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_42_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_42", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 802.4000244140625, "invlev_up": 813.60003662109375, "invlev_dn": 799.9000244140625, "manhole_up": "manhole_859_generated", "manhole_dn": "manhole_860_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387702.553355348296463, 5866735.336608462966979 ], [ 1387692.161796326050535, 5866783.420620376244187 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_43_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_43", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_43", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_861_generated", "manhole_dn": "manhole_862_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387809.534624515566975, 5866309.639251782558858 ], [ 1387788.486613497138023, 5866352.766951287165284 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_43_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_43", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_43", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 830.9000244140625, "invlev_up": 803.70001220703125, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_862_generated", "manhole_dn": "manhole_852_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387788.486613497138023, 5866352.766951287165284 ], [ 1387767.438602478476241, 5866395.894650792703032 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 840.10003662109375, "invlev_up": 828.4000244140625, "invlev_dn": 837.60003662109375, "manhole_up": "manhole_852_generated", "manhole_dn": "manhole_863_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387767.438602478476241, 5866395.894650792703032 ], [ 1387774.73306847945787, 5866351.644692087545991 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 840.10003662109375, "elevtn_dn": 806.20001220703125, "invlev_up": 837.60003662109375, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_863_generated", "manhole_dn": "manhole_864_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387774.73306847945787, 5866351.644692087545991 ], [ 1387787.219046234386042, 5866308.756401930935681 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_864_generated", "manhole_dn": "manhole_865_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387787.219046234386042, 5866308.756401930935681 ], [ 1387802.581935805035755, 5866266.622689731419086 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_865_generated", "manhole_dn": "manhole_866_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387802.581935805035755, 5866266.622689731419086 ], [ 1387818.989883717847988, 5866224.886323318816721 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_866_generated", "manhole_dn": "manhole_867_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387818.989883717847988, 5866224.886323318816721 ], [ 1387838.767447788733989, 5866184.784887914545834 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_867_generated", "manhole_dn": "manhole_868_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387838.767447788733989, 5866184.784887914545834 ], [ 1387862.375427621416748, 5866146.679679537191987 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 803.9000244140625, "invlev_up": 825.20001220703125, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_868_generated", "manhole_dn": "manhole_869_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387862.375427621416748, 5866146.679679537191987 ], [ 1387890.316308293025941, 5866111.904927220195532 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_44_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_44", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_869_generated", "manhole_dn": "manhole_870_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387890.316308293025941, 5866111.904927220195532 ], [ 1387932.086585889104754, 5866099.149365295656025 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_45_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_45", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_871_generated", "manhole_dn": "manhole_872_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387931.614702571649104, 5866170.542120457626879 ], [ 1387899.497387683717534, 5866203.806988564319909 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_45_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_45", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 806.20001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_872_generated", "manhole_dn": "manhole_873_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387899.497387683717534, 5866203.806988564319909 ], [ 1387869.509799961000681, 5866239.084409636445343 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_45_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_45", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_873_generated", "manhole_dn": "manhole_874_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387869.509799961000681, 5866239.084409636445343 ], [ 1387839.522212238283828, 5866274.361830709502101 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_45_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_45", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_874_generated", "manhole_dn": "manhole_861_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387839.522212238283828, 5866274.361830709502101 ], [ 1387809.534624515566975, 5866309.639251782558858 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_46_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_870_generated", "manhole_dn": "manhole_875_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387932.086585889104754, 5866099.149365295656025 ], [ 1387908.367353544337675, 5866141.903963415883482 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_46_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_875_generated", "manhole_dn": "manhole_876_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387908.367353544337675, 5866141.903963415883482 ], [ 1387876.955022902460769, 5866179.987773489207029 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_46_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 827.70001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_876_generated", "manhole_dn": "manhole_877_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387876.955022902460769, 5866179.987773489207029 ], [ 1387847.458594153402373, 5866219.470102892257273 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_46_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_877_generated", "manhole_dn": "manhole_878_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387847.458594153402373, 5866219.470102892257273 ], [ 1387823.639855962945148, 5866262.662997540086508 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_46_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_46", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_878_generated", "manhole_dn": "manhole_861_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387823.639855962945148, 5866262.662997540086508 ], [ 1387809.534624515566975, 5866309.639251782558858 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_47_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_879_generated", "manhole_dn": "manhole_880_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.443674022099003, 5865845.093254727311432 ], [ 1387943.318034203490242, 5865887.628139751963317 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_47_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_880_generated", "manhole_dn": "manhole_881_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387943.318034203490242, 5865887.628139751963317 ], [ 1387946.009428307646886, 5865930.175072746351361 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_47_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 816.70001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_881_generated", "manhole_dn": "manhole_882_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387946.009428307646886, 5865930.175072746351361 ], [ 1387948.700822412036359, 5865972.722005739808083 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_47_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_882_generated", "manhole_dn": "manhole_883_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387948.700822412036359, 5865972.722005739808083 ], [ 1387944.872250664513558, 5866015.105105520226061 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_47_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_883_generated", "manhole_dn": "manhole_884_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387944.872250664513558, 5866015.105105520226061 ], [ 1387940.047370131826028, 5866057.463170127011836 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_47_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_47", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 803.9000244140625, "invlev_up": 814.20001220703125, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_884_generated", "manhole_dn": "manhole_870_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.047370131826028, 5866057.463170127011836 ], [ 1387932.086585889104754, 5866099.149365295656025 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_48_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_48", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_48", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 786.29998779296875, "invlev_up": 801.4000244140625, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_870_generated", "manhole_dn": "manhole_885_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387932.086585889104754, 5866099.149365295656025 ], [ 1387975.279995472636074, 5866107.425722245126963 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E125", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 909.5, "elevtn_dn": 910.4000244140625, "invlev_up": 907.0, "invlev_dn": 907.9000244140625, "manhole_up": "manhole_886_generated", "manhole_dn": "manhole_887_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392926.966794768813998, 5866808.501405037939548 ], [ 1392879.417931769276038, 5866793.491589142940938 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E126", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 910.4000244140625, "elevtn_dn": 910.4000244140625, "invlev_up": 907.9000244140625, "invlev_dn": 907.9000244140625, "manhole_up": "manhole_887_generated", "manhole_dn": "manhole_888_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392879.417931769276038, 5866793.491589142940938 ], [ 1392831.869068769738078, 5866778.481773247942328 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E127", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 910.4000244140625, "elevtn_dn": 865.0, "invlev_up": 907.9000244140625, "invlev_dn": 862.5, "manhole_up": "manhole_888_generated", "manhole_dn": "manhole_889_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392831.869068769738078, 5866778.481773247942328 ], [ 1392784.320205770200118, 5866763.471957352943718 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E128", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 865.0, "elevtn_dn": 865.0, "invlev_up": 862.5, "invlev_dn": 862.5, "manhole_up": "manhole_889_generated", "manhole_dn": "manhole_890_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392784.320205770200118, 5866763.471957352943718 ], [ 1392736.771342770429328, 5866748.462141457945108 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E129", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 865.0, "elevtn_dn": 878.4000244140625, "invlev_up": 862.5, "invlev_dn": 875.9000244140625, "manhole_up": "manhole_890_generated", "manhole_dn": "manhole_891_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392736.771342770429328, 5866748.462141457945108 ], [ 1392689.222479770891368, 5866733.452325562946498 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E130", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 878.4000244140625, "elevtn_dn": 878.4000244140625, "invlev_up": 875.9000244140625, "invlev_dn": 875.9000244140625, "manhole_up": "manhole_891_generated", "manhole_dn": "manhole_892_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392689.222479770891368, 5866733.452325562946498 ], [ 1392641.673616771353409, 5866718.442509667947888 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E131", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 878.4000244140625, "elevtn_dn": 904.9000244140625, "invlev_up": 875.9000244140625, "invlev_dn": 902.4000244140625, "manhole_up": "manhole_892_generated", "manhole_dn": "manhole_893_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392641.673616771353409, 5866718.442509667947888 ], [ 1392594.124753771815449, 5866703.432693773880601 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E132", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 904.9000244140625, "elevtn_dn": 904.9000244140625, "invlev_up": 902.4000244140625, "invlev_dn": 902.4000244140625, "manhole_up": "manhole_893_generated", "manhole_dn": "manhole_894_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392594.124753771815449, 5866703.432693773880601 ], [ 1392546.575890772277489, 5866688.422877878881991 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E133", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 904.9000244140625, "elevtn_dn": 931.5, "invlev_up": 902.4000244140625, "invlev_dn": 929.0, "manhole_up": "manhole_894_generated", "manhole_dn": "manhole_895_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392546.575890772277489, 5866688.422877878881991 ], [ 1392499.02702777273953, 5866673.413061983883381 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E134", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 931.5, "elevtn_dn": 931.5, "invlev_up": 929.0, "invlev_dn": 929.0, "manhole_up": "manhole_895_generated", "manhole_dn": "manhole_896_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392499.02702777273953, 5866673.413061983883381 ], [ 1392451.47816477320157, 5866658.403246088884771 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E135", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 931.5, "elevtn_dn": 926.29998779296875, "invlev_up": 929.0, "invlev_dn": 923.79998779296875, "manhole_up": "manhole_896_generated", "manhole_dn": "manhole_897_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392451.47816477320157, 5866658.403246088884771 ], [ 1392403.92930177366361, 5866643.393430193886161 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E136", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 926.29998779296875, "elevtn_dn": 849.79998779296875, "invlev_up": 923.79998779296875, "invlev_dn": 847.29998779296875, "manhole_up": "manhole_897_generated", "manhole_dn": "manhole_898_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392403.92930177366361, 5866643.393430193886161 ], [ 1392356.380438774125651, 5866628.383614298887551 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E137", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 849.79998779296875, "elevtn_dn": 875.20001220703125, "invlev_up": 847.29998779296875, "invlev_dn": 872.70001220703125, "manhole_up": "manhole_898_generated", "manhole_dn": "manhole_899_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392356.380438774125651, 5866628.383614298887551 ], [ 1392308.831575774587691, 5866613.373798403888941 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E138", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 875.20001220703125, "elevtn_dn": 875.20001220703125, "invlev_up": 872.70001220703125, "invlev_dn": 872.70001220703125, "manhole_up": "manhole_899_generated", "manhole_dn": "manhole_900_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392308.831575774587691, 5866613.373798403888941 ], [ 1392261.282712775049731, 5866598.363982509821653 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E139", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 875.20001220703125, "elevtn_dn": 928.10003662109375, "invlev_up": 872.70001220703125, "invlev_dn": 925.60003662109375, "manhole_up": "manhole_900_generated", "manhole_dn": "manhole_901_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392261.282712775049731, 5866598.363982509821653 ], [ 1392213.733849775511771, 5866583.354166614823043 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E140", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 928.10003662109375, "elevtn_dn": 928.10003662109375, "invlev_up": 925.60003662109375, "invlev_dn": 925.60003662109375, "manhole_up": "manhole_901_generated", "manhole_dn": "manhole_902_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392213.733849775511771, 5866583.354166614823043 ], [ 1392166.184986775973812, 5866568.344350719824433 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E141", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 928.10003662109375, "elevtn_dn": 936.79998779296875, "invlev_up": 925.60003662109375, "invlev_dn": 934.29998779296875, "manhole_up": "manhole_902_generated", "manhole_dn": "manhole_903_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392166.184986775973812, 5866568.344350719824433 ], [ 1392119.234377897810191, 5866551.59017149079591 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E142", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 936.79998779296875, "elevtn_dn": 936.79998779296875, "invlev_up": 934.29998779296875, "invlev_dn": 934.29998779296875, "manhole_up": "manhole_903_generated", "manhole_dn": "manhole_904_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392119.234377897810191, 5866551.59017149079591 ], [ 1392072.481987217208371, 5866534.25803626794368 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E143", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 936.79998779296875, "elevtn_dn": 929.79998779296875, "invlev_up": 934.29998779296875, "invlev_dn": 927.29998779296875, "manhole_up": "manhole_904_generated", "manhole_dn": "manhole_905_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392072.481987217208371, 5866534.25803626794368 ], [ 1392025.729596536839381, 5866516.925901044160128 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E144", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 929.79998779296875, "elevtn_dn": 892.29998779296875, "invlev_up": 927.29998779296875, "invlev_dn": 889.79998779296875, "manhole_up": "manhole_905_generated", "manhole_dn": "manhole_906_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392025.729596536839381, 5866516.925901044160128 ], [ 1391978.977205856470391, 5866499.593765820376575 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E145", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 892.29998779296875, "elevtn_dn": 911.4000244140625, "invlev_up": 889.79998779296875, "invlev_dn": 908.9000244140625, "manhole_up": "manhole_906_generated", "manhole_dn": "manhole_907_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391978.977205856470391, 5866499.593765820376575 ], [ 1391932.224815175868571, 5866482.261630596593022 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E146", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.4000244140625, "elevtn_dn": 911.4000244140625, "invlev_up": 908.9000244140625, "invlev_dn": 908.9000244140625, "manhole_up": "manhole_907_generated", "manhole_dn": "manhole_908_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391932.224815175868571, 5866482.261630596593022 ], [ 1391885.472424495499581, 5866464.92949537280947 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E147", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 911.4000244140625, "elevtn_dn": 933.20001220703125, "invlev_up": 908.9000244140625, "invlev_dn": 930.70001220703125, "manhole_up": "manhole_908_generated", "manhole_dn": "manhole_909_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391885.472424495499581, 5866464.92949537280947 ], [ 1391838.720033814897761, 5866447.59736014995724 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E148", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.20001220703125, "elevtn_dn": 933.20001220703125, "invlev_up": 930.70001220703125, "invlev_dn": 930.70001220703125, "manhole_up": "manhole_909_generated", "manhole_dn": "manhole_910_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391838.720033814897761, 5866447.59736014995724 ], [ 1391791.967643134528771, 5866430.265224926173687 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E149", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 933.20001220703125, "elevtn_dn": 939.4000244140625, "invlev_up": 930.70001220703125, "invlev_dn": 936.9000244140625, "manhole_up": "manhole_910_generated", "manhole_dn": "manhole_911_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391791.967643134528771, 5866430.265224926173687 ], [ 1391745.215252453926951, 5866412.933089702390134 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E150", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 939.4000244140625, "elevtn_dn": 939.4000244140625, "invlev_up": 936.9000244140625, "invlev_dn": 936.9000244140625, "manhole_up": "manhole_911_generated", "manhole_dn": "manhole_912_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391745.215252453926951, 5866412.933089702390134 ], [ 1391698.462861773557961, 5866395.600954478606582 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E151", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 939.4000244140625, "elevtn_dn": 952.70001220703125, "invlev_up": 936.9000244140625, "invlev_dn": 950.20001220703125, "manhole_up": "manhole_912_generated", "manhole_dn": "manhole_913_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391698.462861773557961, 5866395.600954478606582 ], [ 1391651.710471092956141, 5866378.268819254823029 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E152", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 952.70001220703125, "elevtn_dn": 889.4000244140625, "invlev_up": 950.20001220703125, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_913_generated", "manhole_dn": "manhole_914_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391651.710471092956141, 5866378.268819254823029 ], [ 1391604.958080412587151, 5866360.936684031039476 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E153", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 848.70001220703125, "invlev_up": 886.9000244140625, "invlev_dn": 846.20001220703125, "manhole_up": "manhole_914_generated", "manhole_dn": "manhole_915_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391604.958080412587151, 5866360.936684031039476 ], [ 1391558.205689732218161, 5866343.604548808187246 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E154", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 848.70001220703125, "elevtn_dn": 848.70001220703125, "invlev_up": 846.20001220703125, "invlev_dn": 846.20001220703125, "manhole_up": "manhole_915_generated", "manhole_dn": "manhole_916_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391558.205689732218161, 5866343.604548808187246 ], [ 1391511.453299051616341, 5866326.272413584403694 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E155", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 848.70001220703125, "elevtn_dn": 846.0, "invlev_up": 846.20001220703125, "invlev_dn": 843.5, "manhole_up": "manhole_916_generated", "manhole_dn": "manhole_917_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391511.453299051616341, 5866326.272413584403694 ], [ 1391464.700908371247351, 5866308.940278360620141 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E156", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.0, "elevtn_dn": 846.0, "invlev_up": 843.5, "invlev_dn": 843.5, "manhole_up": "manhole_917_generated", "manhole_dn": "manhole_918_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391464.700908371247351, 5866308.940278360620141 ], [ 1391417.948517690645531, 5866291.608143136836588 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E157", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 846.0, "elevtn_dn": 849.9000244140625, "invlev_up": 843.5, "invlev_dn": 847.4000244140625, "manhole_up": "manhole_918_generated", "manhole_dn": "manhole_919_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391417.948517690645531, 5866291.608143136836588 ], [ 1391371.196127010276541, 5866274.276007913053036 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E158", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 849.9000244140625, "elevtn_dn": 849.9000244140625, "invlev_up": 847.4000244140625, "invlev_dn": 847.4000244140625, "manhole_up": "manhole_919_generated", "manhole_dn": "manhole_920_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391371.196127010276541, 5866274.276007913053036 ], [ 1391321.986832652939484, 5866269.550851707346737 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E159", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 849.9000244140625, "elevtn_dn": 895.70001220703125, "invlev_up": 847.4000244140625, "invlev_dn": 893.20001220703125, "manhole_up": "manhole_920_generated", "manhole_dn": "manhole_921_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391321.986832652939484, 5866269.550851707346737 ], [ 1391272.147464629728347, 5866268.058758955448866 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E160", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 895.70001220703125, "elevtn_dn": 895.70001220703125, "invlev_up": 893.20001220703125, "invlev_dn": 893.20001220703125, "manhole_up": "manhole_921_generated", "manhole_dn": "manhole_922_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391272.147464629728347, 5866268.058758955448866 ], [ 1391222.30809660628438, 5866266.566666204482317 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E161", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 895.70001220703125, "elevtn_dn": 932.0, "invlev_up": 893.20001220703125, "invlev_dn": 929.5, "manhole_up": "manhole_922_generated", "manhole_dn": "manhole_923_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391222.30809660628438, 5866266.566666204482317 ], [ 1391172.468728582840413, 5866265.074573452584445 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E162", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 932.0, "invlev_up": 929.5, "invlev_dn": 929.5, "manhole_up": "manhole_923_generated", "manhole_dn": "manhole_924_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391172.468728582840413, 5866265.074573452584445 ], [ 1391122.629360559629276, 5866263.582480700686574 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E163", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 915.20001220703125, "invlev_up": 929.5, "invlev_dn": 912.70001220703125, "manhole_up": "manhole_924_generated", "manhole_dn": "manhole_925_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391122.629360559629276, 5866263.582480700686574 ], [ 1391072.789992536185309, 5866262.090387949720025 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E164", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 915.20001220703125, "elevtn_dn": 880.70001220703125, "invlev_up": 912.70001220703125, "invlev_dn": 878.20001220703125, "manhole_up": "manhole_925_generated", "manhole_dn": "manhole_926_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391072.789992536185309, 5866262.090387949720025 ], [ 1391022.950624512741342, 5866260.598295197822154 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E165", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 880.70001220703125, "elevtn_dn": 880.70001220703125, "invlev_up": 878.20001220703125, "invlev_dn": 878.20001220703125, "manhole_up": "manhole_926_generated", "manhole_dn": "manhole_927_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391022.950624512741342, 5866260.598295197822154 ], [ 1390973.111256489530206, 5866259.106202445924282 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E166", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 880.70001220703125, "elevtn_dn": 889.4000244140625, "invlev_up": 878.20001220703125, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_927_generated", "manhole_dn": "manhole_928_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390973.111256489530206, 5866259.106202445924282 ], [ 1390923.271888466086239, 5866257.614109694957733 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E167", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 889.4000244140625, "invlev_up": 886.9000244140625, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_928_generated", "manhole_dn": "manhole_929_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390923.271888466086239, 5866257.614109694957733 ], [ 1390873.432520442642272, 5866256.122016943059862 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E168", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 935.79998779296875, "invlev_up": 886.9000244140625, "invlev_dn": 933.29998779296875, "manhole_up": "manhole_929_generated", "manhole_dn": "manhole_930_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390873.432520442642272, 5866256.122016943059862 ], [ 1390823.593152419198304, 5866254.62992419116199 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E169", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.79998779296875, "elevtn_dn": 935.79998779296875, "invlev_up": 933.29998779296875, "invlev_dn": 933.29998779296875, "manhole_up": "manhole_930_generated", "manhole_dn": "manhole_931_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390823.593152419198304, 5866254.62992419116199 ], [ 1390773.753784395987168, 5866253.137831440195441 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E170", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.79998779296875, "elevtn_dn": 957.79998779296875, "invlev_up": 933.29998779296875, "invlev_dn": 955.29998779296875, "manhole_up": "manhole_931_generated", "manhole_dn": "manhole_932_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390773.753784395987168, 5866253.137831440195441 ], [ 1390723.914416372543201, 5866251.64573868829757 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E171", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.79998779296875, "elevtn_dn": 957.79998779296875, "invlev_up": 955.29998779296875, "invlev_dn": 955.29998779296875, "manhole_up": "manhole_932_generated", "manhole_dn": "manhole_933_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390723.914416372543201, 5866251.64573868829757 ], [ 1390674.075048349099234, 5866250.153645936399698 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E172", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.79998779296875, "elevtn_dn": 957.0, "invlev_up": 955.29998779296875, "invlev_dn": 954.5, "manhole_up": "manhole_933_generated", "manhole_dn": "manhole_934_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390674.075048349099234, 5866250.153645936399698 ], [ 1390624.235680325888097, 5866248.661553185433149 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E173", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.0, "elevtn_dn": 957.0, "invlev_up": 954.5, "invlev_dn": 954.5, "manhole_up": "manhole_934_generated", "manhole_dn": "manhole_935_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390624.235680325888097, 5866248.661553185433149 ], [ 1390574.39631230244413, 5866247.169460433535278 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E174", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 957.0, "elevtn_dn": 964.5, "invlev_up": 954.5, "invlev_dn": 962.0, "manhole_up": "manhole_935_generated", "manhole_dn": "manhole_936_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390574.39631230244413, 5866247.169460433535278 ], [ 1390524.556944279000163, 5866245.677367681637406 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E175", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 964.5, "invlev_up": 962.0, "invlev_dn": 962.0, "manhole_up": "manhole_936_generated", "manhole_dn": "manhole_937_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390524.556944279000163, 5866245.677367681637406 ], [ 1390474.717576255789027, 5866244.185274930670857 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E176", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 948.5, "invlev_up": 962.0, "invlev_dn": 946.0, "manhole_up": "manhole_937_generated", "manhole_dn": "manhole_938_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390474.717576255789027, 5866244.185274930670857 ], [ 1390424.87820823234506, 5866242.693182178772986 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E177", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 948.5, "elevtn_dn": 970.10003662109375, "invlev_up": 946.0, "invlev_dn": 967.60003662109375, "manhole_up": "manhole_938_generated", "manhole_dn": "manhole_939_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390424.87820823234506, 5866242.693182178772986 ], [ 1390375.038840208901092, 5866241.201089426875114 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E178", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 970.10003662109375, "elevtn_dn": 970.10003662109375, "invlev_up": 967.60003662109375, "invlev_dn": 967.60003662109375, "manhole_up": "manhole_939_generated", "manhole_dn": "manhole_940_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390375.038840208901092, 5866241.201089426875114 ], [ 1390325.199472185689956, 5866239.708996675908566 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E179", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 970.10003662109375, "elevtn_dn": 975.4000244140625, "invlev_up": 967.60003662109375, "invlev_dn": 972.9000244140625, "manhole_up": "manhole_940_generated", "manhole_dn": "manhole_941_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390325.199472185689956, 5866239.708996675908566 ], [ 1390275.360104162245989, 5866238.216903924010694 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E180", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 975.4000244140625, "elevtn_dn": 975.4000244140625, "invlev_up": 972.9000244140625, "invlev_dn": 972.9000244140625, "manhole_up": "manhole_941_generated", "manhole_dn": "manhole_942_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390275.360104162245989, 5866238.216903924010694 ], [ 1390225.520736138802022, 5866236.724811173044145 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E181", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 975.4000244140625, "elevtn_dn": 1034.5, "invlev_up": 972.9000244140625, "invlev_dn": 1032.0, "manhole_up": "manhole_942_generated", "manhole_dn": "manhole_943_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390225.520736138802022, 5866236.724811173044145 ], [ 1390175.681368115358055, 5866235.232718421146274 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E182", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1034.5, "elevtn_dn": 1034.5, "invlev_up": 1032.0, "invlev_dn": 1032.0, "manhole_up": "manhole_943_generated", "manhole_dn": "manhole_944_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390175.681368115358055, 5866235.232718421146274 ], [ 1390125.842000092146918, 5866233.740625669248402 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E183", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1034.5, "elevtn_dn": 1053.9000244140625, "invlev_up": 1032.0, "invlev_dn": 1051.4000244140625, "manhole_up": "manhole_944_generated", "manhole_dn": "manhole_945_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390125.842000092146918, 5866233.740625669248402 ], [ 1390076.002632068702951, 5866232.248532918281853 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E184", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.9000244140625, "elevtn_dn": 956.9000244140625, "invlev_up": 1051.4000244140625, "invlev_dn": 954.4000244140625, "manhole_up": "manhole_945_generated", "manhole_dn": "manhole_946_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390076.002632068702951, 5866232.248532918281853 ], [ 1390026.163264045258984, 5866230.756440166383982 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E185", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 956.9000244140625, "elevtn_dn": 988.79998779296875, "invlev_up": 954.4000244140625, "invlev_dn": 986.29998779296875, "manhole_up": "manhole_946_generated", "manhole_dn": "manhole_947_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390026.163264045258984, 5866230.756440166383982 ], [ 1389976.323896022047848, 5866229.26434741448611 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E186", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 988.79998779296875, "elevtn_dn": 988.79998779296875, "invlev_up": 986.29998779296875, "invlev_dn": 986.29998779296875, "manhole_up": "manhole_947_generated", "manhole_dn": "manhole_948_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389976.323896022047848, 5866229.26434741448611 ], [ 1389926.48452799860388, 5866227.772254663519561 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E187", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 988.79998779296875, "elevtn_dn": 1051.0999755859375, "invlev_up": 986.29998779296875, "invlev_dn": 1048.5999755859375, "manhole_up": "manhole_948_generated", "manhole_dn": "manhole_949_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389926.48452799860388, 5866227.772254663519561 ], [ 1389876.645159975159913, 5866226.28016191162169 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E188", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1051.0999755859375, "elevtn_dn": 1051.0999755859375, "invlev_up": 1048.5999755859375, "invlev_dn": 1048.5999755859375, "manhole_up": "manhole_949_generated", "manhole_dn": "manhole_950_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389876.645159975159913, 5866226.28016191162169 ], [ 1389826.805791951948777, 5866224.788069159723818 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E189", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1051.0999755859375, "elevtn_dn": 1066.9000244140625, "invlev_up": 1048.5999755859375, "invlev_dn": 1064.4000244140625, "manhole_up": "manhole_950_generated", "manhole_dn": "manhole_951_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389826.805791951948777, 5866224.788069159723818 ], [ 1389776.96642392850481, 5866223.295976408757269 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E190", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1066.9000244140625, "elevtn_dn": 1031.2000732421875, "invlev_up": 1064.4000244140625, "invlev_dn": 1028.7000732421875, "manhole_up": "manhole_951_generated", "manhole_dn": "manhole_952_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389776.96642392850481, 5866223.295976408757269 ], [ 1389727.141182830790058, 5866221.468200048431754 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E191", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1031.2000732421875, "elevtn_dn": 1031.2000732421875, "invlev_up": 1028.7000732421875, "invlev_dn": 1028.7000732421875, "manhole_up": "manhole_952_generated", "manhole_dn": "manhole_953_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389727.141182830790058, 5866221.468200048431754 ], [ 1389677.352675863076001, 5866218.767548334784806 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E192", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1031.2000732421875, "elevtn_dn": 986.60003662109375, "invlev_up": 1028.7000732421875, "invlev_dn": 984.10003662109375, "manhole_up": "manhole_953_generated", "manhole_dn": "manhole_954_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389677.352675863076001, 5866218.767548334784806 ], [ 1389627.564168895594776, 5866216.066896621137857 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E193", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 986.60003662109375, "elevtn_dn": 986.60003662109375, "invlev_up": 984.10003662109375, "invlev_dn": 984.10003662109375, "manhole_up": "manhole_954_generated", "manhole_dn": "manhole_955_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389627.564168895594776, 5866216.066896621137857 ], [ 1389577.775661927880719, 5866213.366244907490909 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E194", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 986.60003662109375, "elevtn_dn": 964.70001220703125, "invlev_up": 984.10003662109375, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_955_generated", "manhole_dn": "manhole_956_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389577.775661927880719, 5866213.366244907490909 ], [ 1389527.987154960166663, 5866210.665593194775283 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E195", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 964.70001220703125, "invlev_up": 962.20001220703125, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_956_generated", "manhole_dn": "manhole_957_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389527.987154960166663, 5866210.665593194775283 ], [ 1389478.198647992452607, 5866207.964941481128335 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E196", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 996.29998779296875, "invlev_up": 962.20001220703125, "invlev_dn": 993.79998779296875, "manhole_up": "manhole_957_generated", "manhole_dn": "manhole_958_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389478.198647992452607, 5866207.964941481128335 ], [ 1389428.41014102473855, 5866205.264289767481387 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E197", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 996.29998779296875, "elevtn_dn": 996.29998779296875, "invlev_up": 993.79998779296875, "invlev_dn": 993.79998779296875, "manhole_up": "manhole_958_generated", "manhole_dn": "manhole_959_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389428.41014102473855, 5866205.264289767481387 ], [ 1389378.621634057024494, 5866202.563638053834438 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E198", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 996.29998779296875, "elevtn_dn": 1030.4000244140625, "invlev_up": 993.79998779296875, "invlev_dn": 1027.9000244140625, "manhole_up": "manhole_959_generated", "manhole_dn": "manhole_960_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389378.621634057024494, 5866202.563638053834438 ], [ 1389328.833127089310437, 5866199.86298634018749 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E199", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1030.4000244140625, "elevtn_dn": 1030.4000244140625, "invlev_up": 1027.9000244140625, "invlev_dn": 1027.9000244140625, "manhole_up": "manhole_960_generated", "manhole_dn": "manhole_961_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389328.833127089310437, 5866199.86298634018749 ], [ 1389279.044620121829212, 5866197.162334626540542 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E200", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1030.4000244140625, "elevtn_dn": 1053.800048828125, "invlev_up": 1027.9000244140625, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_961_generated", "manhole_dn": "manhole_962_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389279.044620121829212, 5866197.162334626540542 ], [ 1389229.256113154115155, 5866194.461682912893593 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E201", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1053.800048828125, "invlev_up": 1051.300048828125, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_962_generated", "manhole_dn": "manhole_963_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389229.256113154115155, 5866194.461682912893593 ], [ 1389179.467606186401099, 5866191.761031199246645 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E202", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1067.5999755859375, "invlev_up": 1051.300048828125, "invlev_dn": 1065.0999755859375, "manhole_up": "manhole_963_generated", "manhole_dn": "manhole_964_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389179.467606186401099, 5866191.761031199246645 ], [ 1389129.679099218687043, 5866189.060379485599697 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E203", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1067.5999755859375, "elevtn_dn": 1070.7000732421875, "invlev_up": 1065.0999755859375, "invlev_dn": 1068.2000732421875, "manhole_up": "manhole_964_generated", "manhole_dn": "manhole_965_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389129.679099218687043, 5866189.060379485599697 ], [ 1389079.890592250972986, 5866186.359727771952748 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E204", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1070.7000732421875, "elevtn_dn": 1070.7000732421875, "invlev_up": 1068.2000732421875, "invlev_dn": 1068.2000732421875, "manhole_up": "manhole_965_generated", "manhole_dn": "manhole_966_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389079.890592250972986, 5866186.359727771952748 ], [ 1389030.10208528325893, 5866183.6590760583058 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E205", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1070.7000732421875, "elevtn_dn": 1075.0, "invlev_up": 1068.2000732421875, "invlev_dn": 1072.5, "manhole_up": "manhole_966_generated", "manhole_dn": "manhole_967_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389030.10208528325893, 5866183.6590760583058 ], [ 1388980.313578315777704, 5866180.958424345590174 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E206", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1075.0, "elevtn_dn": 1075.0, "invlev_up": 1072.5, "invlev_dn": 1072.5, "manhole_up": "manhole_967_generated", "manhole_dn": "manhole_968_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388980.313578315777704, 5866180.958424345590174 ], [ 1388930.525071348063648, 5866178.257772631943226 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E207", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1075.0, "elevtn_dn": 1074.0999755859375, "invlev_up": 1072.5, "invlev_dn": 1071.5999755859375, "manhole_up": "manhole_968_generated", "manhole_dn": "manhole_969_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388930.525071348063648, 5866178.257772631943226 ], [ 1388880.736564380349591, 5866175.557120918296278 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E208", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1074.0999755859375, "elevtn_dn": 1074.0999755859375, "invlev_up": 1071.5999755859375, "invlev_dn": 1071.5999755859375, "manhole_up": "manhole_969_generated", "manhole_dn": "manhole_970_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388880.736564380349591, 5866175.557120918296278 ], [ 1388830.948057412635535, 5866172.856469204649329 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E209", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1074.0999755859375, "elevtn_dn": 1053.800048828125, "invlev_up": 1071.5999755859375, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_970_generated", "manhole_dn": "manhole_971_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388830.948057412635535, 5866172.856469204649329 ], [ 1388781.159550444921479, 5866170.155817491002381 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E210", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1053.800048828125, "invlev_up": 1051.300048828125, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_971_generated", "manhole_dn": "manhole_972_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388781.159550444921479, 5866170.155817491002381 ], [ 1388731.371043477207422, 5866167.455165777355433 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E211", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1017.0, "invlev_up": 1051.300048828125, "invlev_dn": 1014.5, "manhole_up": "manhole_972_generated", "manhole_dn": "manhole_973_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388731.371043477207422, 5866167.455165777355433 ], [ 1388681.582536509493366, 5866164.754514063708484 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E212", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1017.0, "elevtn_dn": 1017.0, "invlev_up": 1014.5, "invlev_dn": 1014.5, "manhole_up": "manhole_973_generated", "manhole_dn": "manhole_974_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388681.582536509493366, 5866164.754514063708484 ], [ 1388631.79402954201214, 5866162.053862350061536 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E213", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 1017.0, "elevtn_dn": 973.20001220703125, "invlev_up": 1014.5, "invlev_dn": 970.70001220703125, "manhole_up": "manhole_974_generated", "manhole_dn": "manhole_975_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388631.79402954201214, 5866162.053862350061536 ], [ 1388582.005522574298084, 5866159.353210636414587 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E214", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 973.20001220703125, "elevtn_dn": 973.20001220703125, "invlev_up": 970.70001220703125, "invlev_dn": 970.70001220703125, "manhole_up": "manhole_975_generated", "manhole_dn": "manhole_976_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388582.005522574298084, 5866159.353210636414587 ], [ 1388532.217015606584027, 5866156.652558922767639 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E215", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 973.20001220703125, "elevtn_dn": 935.20001220703125, "invlev_up": 970.70001220703125, "invlev_dn": 932.70001220703125, "manhole_up": "manhole_976_generated", "manhole_dn": "manhole_977_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388532.217015606584027, 5866156.652558922767639 ], [ 1388482.428508638869971, 5866153.951907209120691 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E216", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.20001220703125, "elevtn_dn": 935.20001220703125, "invlev_up": 932.70001220703125, "invlev_dn": 932.70001220703125, "manhole_up": "manhole_977_generated", "manhole_dn": "manhole_978_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388482.428508638869971, 5866153.951907209120691 ], [ 1388432.640001671155915, 5866151.251255496405065 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E217", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 935.20001220703125, "elevtn_dn": 895.79998779296875, "invlev_up": 932.70001220703125, "invlev_dn": 893.29998779296875, "manhole_up": "manhole_978_generated", "manhole_dn": "manhole_979_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388432.640001671155915, 5866151.251255496405065 ], [ 1388382.851494703441858, 5866148.550603782758117 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E218", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 895.79998779296875, "elevtn_dn": 852.60003662109375, "invlev_up": 893.29998779296875, "invlev_dn": 850.10003662109375, "manhole_up": "manhole_979_generated", "manhole_dn": "manhole_980_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388382.851494703441858, 5866148.550603782758117 ], [ 1388333.062987735960633, 5866145.849952069111168 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E219", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 852.60003662109375, "elevtn_dn": 852.60003662109375, "invlev_up": 850.10003662109375, "invlev_dn": 850.10003662109375, "manhole_up": "manhole_980_generated", "manhole_dn": "manhole_981_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388333.062987735960633, 5866145.849952069111168 ], [ 1388283.274480768246576, 5866143.14930035546422 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E220", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 852.60003662109375, "elevtn_dn": 818.4000244140625, "invlev_up": 850.10003662109375, "invlev_dn": 815.9000244140625, "manhole_up": "manhole_981_generated", "manhole_dn": "manhole_982_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388283.274480768246576, 5866143.14930035546422 ], [ 1388233.48597380053252, 5866140.448648641817272 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_49_E221", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_49", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.4000244140625, "elevtn_dn": 818.4000244140625, "invlev_up": 815.9000244140625, "invlev_dn": 815.9000244140625, "manhole_up": "manhole_982_generated", "manhole_dn": "manhole_983_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388233.48597380053252, 5866140.448648641817272 ], [ 1388183.697466832818463, 5866137.747996928170323 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 792.20001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_851_generated", "manhole_dn": "manhole_984_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387913.197226775344461, 5865736.839239663444459 ], [ 1387925.20445894007571, 5865784.545682998374104 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 804.4000244140625, "invlev_up": 792.20001220703125, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_984_generated", "manhole_dn": "manhole_985_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387925.20445894007571, 5865784.545682998374104 ], [ 1387937.21169110503979, 5865832.252126332372427 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_985_generated", "manhole_dn": "manhole_986_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387937.21169110503979, 5865832.252126332372427 ], [ 1387954.8270876808092, 5865878.043407939374447 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_986_generated", "manhole_dn": "manhole_987_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387954.8270876808092, 5865878.043407939374447 ], [ 1387967.620662312954664, 5865925.436966767534614 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 778.20001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_987_generated", "manhole_dn": "manhole_988_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387967.620662312954664, 5865925.436966767534614 ], [ 1387969.561903131194413, 5865974.386314341798425 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_988_generated", "manhole_dn": "manhole_989_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.561903131194413, 5865974.386314341798425 ], [ 1387968.98255812516436, 5866023.571071763522923 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_989_generated", "manhole_dn": "manhole_990_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387968.98255812516436, 5866023.571071763522923 ], [ 1387969.225197304505855, 5866072.657253311946988 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 786.29998779296875, "invlev_up": 775.70001220703125, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_990_generated", "manhole_dn": "manhole_991_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.225197304505855, 5866072.657253311946988 ], [ 1387988.247399942483753, 5866112.298415473662317 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_50_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_50", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 786.29998779296875, "invlev_up": 783.79998779296875, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_991_generated", "manhole_dn": "manhole_992_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387988.247399942483753, 5866112.298415473662317 ], [ 1388034.037428337847814, 5866130.255607943050563 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 786.29998779296875, "invlev_up": 783.79998779296875, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_992_generated", "manhole_dn": "manhole_993_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388034.037428337847814, 5866130.255607943050563 ], [ 1387988.210684564430267, 5866144.678138472139835 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 803.9000244140625, "invlev_up": 783.79998779296875, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_993_generated", "manhole_dn": "manhole_994_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387988.210684564430267, 5866144.678138472139835 ], [ 1387944.406121137319133, 5866164.065103021450341 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_994_generated", "manhole_dn": "manhole_995_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387944.406121137319133, 5866164.065103021450341 ], [ 1387898.376188111724332, 5866173.560075835324824 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E3", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 827.70001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_995_generated", "manhole_dn": "manhole_996_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387898.376188111724332, 5866173.560075835324824 ], [ 1387861.922560503939167, 5866145.113870099186897 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E4", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_996_generated", "manhole_dn": "manhole_997_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387861.922560503939167, 5866145.113870099186897 ], [ 1387862.597008766839281, 5866099.287653629668057 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E5", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_997_generated", "manhole_dn": "manhole_998_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387862.597008766839281, 5866099.287653629668057 ], [ 1387894.296242429409176, 5866064.31225199252367 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E6", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_998_generated", "manhole_dn": "manhole_999_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387894.296242429409176, 5866064.31225199252367 ], [ 1387918.333023339277133, 5866023.860149594023824 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E7", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_999_generated", "manhole_dn": "manhole_1000_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387918.333023339277133, 5866023.860149594023824 ], [ 1387925.576027213362977, 5865976.462517648003995 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E8", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 804.4000244140625, "invlev_up": 814.20001220703125, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1000_generated", "manhole_dn": "manhole_1001_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387925.576027213362977, 5865976.462517648003995 ], [ 1387926.166851800866425, 5865928.505292822606862 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E9", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1001_generated", "manhole_dn": "manhole_1002_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387926.166851800866425, 5865928.505292822606862 ], [ 1387922.175474973395467, 5865880.628693707287312 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E10", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1002_generated", "manhole_dn": "manhole_1003_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387922.175474973395467, 5865880.628693707287312 ], [ 1387918.184098146157339, 5865832.752094592899084 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E11", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 794.70001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_1003_generated", "manhole_dn": "manhole_1004_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387918.184098146157339, 5865832.752094592899084 ], [ 1387914.316889721900225, 5865784.868878290057182 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_51_E12", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_51", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 792.20001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_1004_generated", "manhole_dn": "manhole_851_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387914.316889721900225, 5865784.868878290057182 ], [ 1387913.197226775344461, 5865736.839239663444459 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_52_E0", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_52", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 818.4000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 815.9000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_983_generated", "manhole_dn": "manhole_1005_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388183.697466832818463, 5866137.747996928170323 ], [ 1388133.810787334572524, 5866135.250533932819963 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_52_E1", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_52", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_1005_generated", "manhole_dn": "manhole_1006_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388133.810787334572524, 5866135.250533932819963 ], [ 1388083.924107836093754, 5866132.753070938400924 ] ] } }, -{ "type": "Feature", "properties": { "height": null, "bedlev": null, "width": null, "branchid": "pipe_52_E2", "branchtype": "pipe", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "frictiontype": "WhiteColeBrook", "frictionvalue": "0.003", "ORIG_branchid": "pipe_52", "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": "0.5", "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 786.29998779296875, "invlev_up": 801.4000244140625, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_1006_generated", "manhole_dn": "manhole_992_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388083.924107836093754, 5866132.753070938400924 ], [ 1388034.037428337847814, 5866130.255607943050563 ] ] } } -======= -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_6_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_1_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389238.298387300921604, 5860147.714495398104191 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_6_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 933.5, "invlev_up": 913.4000244140625, "invlev_dn": 931.0, "manhole_up": "manhole_1_generated", "manhole_dn": "manhole_2_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389238.298387300921604, 5860147.714495398104191 ], [ 1389210.947846550960094, 5860184.343885350972414 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_6_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 933.5, "elevtn_dn": 933.5, "invlev_up": 931.0, "invlev_dn": 931.0, "manhole_up": "manhole_2_generated", "manhole_dn": "manhole_3_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389210.947846550960094, 5860184.343885350972414 ], [ 1389186.961922727525234, 5860223.315261371433735 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_6_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 933.5, "elevtn_dn": 935.5, "invlev_up": 931.0, "invlev_dn": 933.0, "manhole_up": "manhole_3_generated", "manhole_dn": "manhole_4_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389186.961922727525234, 5860223.315261371433735 ], [ 1389162.755598766496405, 5860262.142883376218379 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_6_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 935.5, "invlev_up": 933.0, "invlev_dn": 933.0, "manhole_up": "manhole_4_generated", "manhole_dn": "manhole_5_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389162.755598766496405, 5860262.142883376218379 ], [ 1389136.759307563304901, 5860299.80301527120173 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_6_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 936.5, "invlev_up": 933.0, "invlev_dn": 934.0, "manhole_up": "manhole_5_generated", "manhole_dn": "manhole_6_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389136.759307563304901, 5860299.80301527120173 ], [ 1389109.7301227634307, 5860336.652257356792688 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_6_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 936.5, "elevtn_dn": 941.10003662109375, "invlev_up": 934.0, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_6_generated", "manhole_dn": "manhole_7_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389109.7301227634307, 5860336.652257356792688 ], [ 1389073.18478828552179, 5860363.522737024351954 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_6_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_7_generated", "manhole_dn": "manhole_8_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389073.18478828552179, 5860363.522737024351954 ], [ 1389032.546542100608349, 5860384.329287325032055 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_6_E8", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_8_generated", "manhole_dn": "manhole_9_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389032.546542100608349, 5860384.329287325032055 ], [ 1388989.578410296700895, 5860400.071978960186243 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_6_E9", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 951.29998779296875, "invlev_up": 938.60003662109375, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_9_generated", "manhole_dn": "manhole_10_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388989.578410296700895, 5860400.071978960186243 ], [ 1388946.301100668497384, 5860414.883977899327874 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_7_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_11_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389221.905703959986567, 5860123.3256367566064 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_7_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_11_generated", "manhole_dn": "manhole_12_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389221.905703959986567, 5860123.3256367566064 ], [ 1389177.295895804418251, 5860134.962970778346062 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_7_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 919.60003662109375, "invlev_up": 913.4000244140625, "invlev_dn": 917.10003662109375, "manhole_up": "manhole_12_generated", "manhole_dn": "manhole_13_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389177.295895804418251, 5860134.962970778346062 ], [ 1389132.686087648617104, 5860146.600304800085723 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_7_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 919.60003662109375, "elevtn_dn": 919.60003662109375, "invlev_up": 917.10003662109375, "invlev_dn": 917.10003662109375, "manhole_up": "manhole_13_generated", "manhole_dn": "manhole_14_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389132.686087648617104, 5860146.600304800085723 ], [ 1389088.076279493048787, 5860158.237638821825385 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_7_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 919.60003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 917.10003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_14_generated", "manhole_dn": "manhole_15_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389088.076279493048787, 5860158.237638821825385 ], [ 1389044.226173994829878, 5860172.143308508209884 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_7_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 935.60003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_15_generated", "manhole_dn": "manhole_16_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389044.226173994829878, 5860172.143308508209884 ], [ 1389012.527182487538084, 5860198.239755615592003 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_7_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 935.60003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_16_generated", "manhole_dn": "manhole_17_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389012.527182487538084, 5860198.239755615592003 ], [ 1388995.773122631013393, 5860240.481283166445792 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_7_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 945.0, "invlev_up": 935.60003662109375, "invlev_dn": 942.5, "manhole_up": "manhole_17_generated", "manhole_dn": "manhole_18_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388995.773122631013393, 5860240.481283166445792 ], [ 1388973.630034049740061, 5860280.918223639950156 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_7_E8", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.0, "elevtn_dn": 951.29998779296875, "invlev_up": 942.5, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_18_generated", "manhole_dn": "manhole_19_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388973.630034049740061, 5860280.918223639950156 ], [ 1388961.171157888136804, 5860324.081192856654525 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_7_E9", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_19_generated", "manhole_dn": "manhole_20_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388961.171157888136804, 5860324.081192856654525 ], [ 1388955.410555170848966, 5860369.690168970264494 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_7_E10", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_20_generated", "manhole_dn": "manhole_10_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388955.410555170848966, 5860369.690168970264494 ], [ 1388946.301100668497384, 5860414.883977899327874 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 914.5, "invlev_up": 913.4000244140625, "invlev_dn": 912.0, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_21_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389306.50000010849908, 5860083.476415127515793 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 914.5, "elevtn_dn": 914.5, "invlev_up": 912.0, "invlev_dn": 912.0, "manhole_up": "manhole_21_generated", "manhole_dn": "manhole_22_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389306.50000010849908, 5860083.476415127515793 ], [ 1389355.420758404070511, 5860074.630405306816101 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 914.5, "elevtn_dn": 929.9000244140625, "invlev_up": 912.0, "invlev_dn": 927.4000244140625, "manhole_up": "manhole_22_generated", "manhole_dn": "manhole_23_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389355.420758404070511, 5860074.630405306816101 ], [ 1389389.090761042200029, 5860042.4449307853356 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 929.9000244140625, "elevtn_dn": 955.0, "invlev_up": 927.4000244140625, "invlev_dn": 952.5, "manhole_up": "manhole_23_generated", "manhole_dn": "manhole_24_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389389.090761042200029, 5860042.4449307853356 ], [ 1389404.036260401364416, 5859994.775433851405978 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_24_generated", "manhole_dn": "manhole_25_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389404.036260401364416, 5859994.775433851405978 ], [ 1389418.744130451697856, 5859947.032028519548476 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_25_generated", "manhole_dn": "manhole_26_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389418.744130451697856, 5859947.032028519548476 ], [ 1389423.265342897269875, 5859897.853969652205706 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 975.29998779296875, "invlev_up": 952.5, "invlev_dn": 972.79998779296875, "manhole_up": "manhole_26_generated", "manhole_dn": "manhole_27_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389423.265342897269875, 5859897.853969652205706 ], [ 1389395.831073811277747, 5859856.743154510855675 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 975.29998779296875, "elevtn_dn": 963.0, "invlev_up": 972.79998779296875, "invlev_dn": 960.5, "manhole_up": "manhole_27_generated", "manhole_dn": "manhole_28_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389395.831073811277747, 5859856.743154510855675 ], [ 1389350.827042841585353, 5859839.640478814020753 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E8", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 963.0, "elevtn_dn": 963.0, "invlev_up": 960.5, "invlev_dn": 960.5, "manhole_up": "manhole_28_generated", "manhole_dn": "manhole_29_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389350.827042841585353, 5859839.640478814020753 ], [ 1389303.795788601972163, 5859855.887689013034105 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E9", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 963.0, "elevtn_dn": 945.4000244140625, "invlev_up": 960.5, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_29_generated", "manhole_dn": "manhole_30_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389303.795788601972163, 5859855.887689013034105 ], [ 1389256.284586790716276, 5859863.631580747663975 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E10", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 945.4000244140625, "invlev_up": 942.9000244140625, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_30_generated", "manhole_dn": "manhole_31_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389256.284586790716276, 5859863.631580747663975 ], [ 1389227.308454349869862, 5859823.781623384915292 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E11", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 945.4000244140625, "invlev_up": 942.9000244140625, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_31_generated", "manhole_dn": "manhole_32_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389227.308454349869862, 5859823.781623384915292 ], [ 1389202.745489193825051, 5859780.279727600514889 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E12", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 959.10003662109375, "invlev_up": 942.9000244140625, "invlev_dn": 956.60003662109375, "manhole_up": "manhole_32_generated", "manhole_dn": "manhole_33_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389202.745489193825051, 5859780.279727600514889 ], [ 1389178.18252403778024, 5859736.777831817045808 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E13", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 959.10003662109375, "elevtn_dn": 944.79998779296875, "invlev_up": 956.60003662109375, "invlev_dn": 942.29998779296875, "manhole_up": "manhole_33_generated", "manhole_dn": "manhole_34_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389178.18252403778024, 5859736.777831817045808 ], [ 1389155.231297271326184, 5859692.450142606161535 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E14", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 944.79998779296875, "elevtn_dn": 944.79998779296875, "invlev_up": 942.29998779296875, "invlev_dn": 942.29998779296875, "manhole_up": "manhole_34_generated", "manhole_dn": "manhole_35_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389155.231297271326184, 5859692.450142606161535 ], [ 1389141.413412723457441, 5859644.883844587020576 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E15", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 944.79998779296875, "elevtn_dn": 952.4000244140625, "invlev_up": 942.29998779296875, "invlev_dn": 949.9000244140625, "manhole_up": "manhole_35_generated", "manhole_dn": "manhole_36_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389141.413412723457441, 5859644.883844587020576 ], [ 1389151.802280035568401, 5859598.61804121825844 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E16", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.4000244140625, "elevtn_dn": 960.70001220703125, "invlev_up": 949.9000244140625, "invlev_dn": 958.20001220703125, "manhole_up": "manhole_36_generated", "manhole_dn": "manhole_37_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389151.802280035568401, 5859598.61804121825844 ], [ 1389191.073854762827978, 5859569.046822287142277 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E17", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 960.70001220703125, "elevtn_dn": 960.70001220703125, "invlev_up": 958.20001220703125, "invlev_dn": 958.20001220703125, "manhole_up": "manhole_37_generated", "manhole_dn": "manhole_38_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389191.073854762827978, 5859569.046822287142277 ], [ 1389239.915165816899389, 5859563.955490378662944 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E18", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 960.70001220703125, "elevtn_dn": 969.60003662109375, "invlev_up": 958.20001220703125, "invlev_dn": 967.10003662109375, "manhole_up": "manhole_38_generated", "manhole_dn": "manhole_39_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389239.915165816899389, 5859563.955490378662944 ], [ 1389289.757686472963542, 5859566.285022127442062 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E19", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 969.60003662109375, "elevtn_dn": 969.60003662109375, "invlev_up": 967.10003662109375, "invlev_dn": 967.10003662109375, "manhole_up": "manhole_39_generated", "manhole_dn": "manhole_40_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389289.757686472963542, 5859566.285022127442062 ], [ 1389339.615828452631831, 5859566.079234052449465 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E20", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 969.60003662109375, "elevtn_dn": 976.29998779296875, "invlev_up": 967.10003662109375, "invlev_dn": 973.79998779296875, "manhole_up": "manhole_40_generated", "manhole_dn": "manhole_41_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389339.615828452631831, 5859566.079234052449465 ], [ 1389387.354307833593339, 5859551.676988741382957 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E21", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 976.29998779296875, "elevtn_dn": 976.29998779296875, "invlev_up": 973.79998779296875, "invlev_dn": 973.79998779296875, "manhole_up": "manhole_41_generated", "manhole_dn": "manhole_42_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389387.354307833593339, 5859551.676988741382957 ], [ 1389428.692968821851537, 5859524.248876142315567 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E22", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 976.29998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 973.79998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_42_generated", "manhole_dn": "manhole_43_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389428.692968821851537, 5859524.248876142315567 ], [ 1389461.138921525795013, 5859486.477508954703808 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E23", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_43_generated", "manhole_dn": "manhole_44_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389461.138921525795013, 5859486.477508954703808 ], [ 1389482.45163832209073, 5859441.487986368127167 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E24", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_44_generated", "manhole_dn": "manhole_45_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389482.45163832209073, 5859441.487986368127167 ], [ 1389497.215460168197751, 5859393.906833835877478 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E25", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_45_generated", "manhole_dn": "manhole_46_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389497.215460168197751, 5859393.906833835877478 ], [ 1389508.394423164660111, 5859345.216126504354179 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E26", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 954.79998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_46_generated", "manhole_dn": "manhole_47_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389508.394423164660111, 5859345.216126504354179 ], [ 1389518.522437864448875, 5859296.29671473056078 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E27", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 954.79998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_47_generated", "manhole_dn": "manhole_48_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389518.522437864448875, 5859296.29671473056078 ], [ 1389528.588071504374966, 5859247.363727764226496 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E28", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 950.20001220703125, "invlev_up": 954.79998779296875, "invlev_dn": 947.70001220703125, "manhole_up": "manhole_48_generated", "manhole_dn": "manhole_49_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389528.588071504374966, 5859247.363727764226496 ], [ 1389538.653705144301057, 5859198.43074079696089 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E29", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 950.20001220703125, "elevtn_dn": 957.60003662109375, "invlev_up": 947.70001220703125, "invlev_dn": 955.10003662109375, "manhole_up": "manhole_49_generated", "manhole_dn": "manhole_50_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389538.653705144301057, 5859198.43074079696089 ], [ 1389548.719338784459978, 5859149.497753830626607 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E30", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.60003662109375, "elevtn_dn": 957.60003662109375, "invlev_up": 955.10003662109375, "invlev_dn": 955.10003662109375, "manhole_up": "manhole_50_generated", "manhole_dn": "manhole_51_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389548.719338784459978, 5859149.497753830626607 ], [ 1389558.784972424386069, 5859100.564766863361001 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E31", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.60003662109375, "elevtn_dn": 954.79998779296875, "invlev_up": 955.10003662109375, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_51_generated", "manhole_dn": "manhole_52_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389558.784972424386069, 5859100.564766863361001 ], [ 1389568.85060606431216, 5859051.631779897026718 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E32", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 954.79998779296875, "invlev_up": 952.29998779296875, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_52_generated", "manhole_dn": "manhole_53_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389568.85060606431216, 5859051.631779897026718 ], [ 1389578.916239704471081, 5859002.698792929761112 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E33", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 954.79998779296875, "invlev_up": 952.29998779296875, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_53_generated", "manhole_dn": "manhole_54_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389578.916239704471081, 5859002.698792929761112 ], [ 1389588.981873344397172, 5858953.765805963426828 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E34", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 956.10003662109375, "invlev_up": 952.29998779296875, "invlev_dn": 953.60003662109375, "manhole_up": "manhole_54_generated", "manhole_dn": "manhole_55_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389588.981873344397172, 5858953.765805963426828 ], [ 1389599.047506984323263, 5858904.832818996161222 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E35", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 956.10003662109375, "elevtn_dn": 956.10003662109375, "invlev_up": 953.60003662109375, "invlev_dn": 953.60003662109375, "manhole_up": "manhole_55_generated", "manhole_dn": "manhole_56_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389599.047506984323263, 5858904.832818996161222 ], [ 1389613.243873829254881, 5858857.048414096236229 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E36", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 956.10003662109375, "elevtn_dn": 966.29998779296875, "invlev_up": 953.60003662109375, "invlev_dn": 963.79998779296875, "manhole_up": "manhole_56_generated", "manhole_dn": "manhole_57_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389613.243873829254881, 5858857.048414096236229 ], [ 1389631.198101107496768, 5858810.554778259247541 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E37", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 966.29998779296875, "elevtn_dn": 968.70001220703125, "invlev_up": 963.79998779296875, "invlev_dn": 966.20001220703125, "manhole_up": "manhole_57_generated", "manhole_dn": "manhole_58_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389631.198101107496768, 5858810.554778259247541 ], [ 1389656.490605737781152, 5858767.472956065088511 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E38", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 968.70001220703125, "elevtn_dn": 968.70001220703125, "invlev_up": 966.20001220703125, "invlev_dn": 966.20001220703125, "manhole_up": "manhole_58_generated", "manhole_dn": "manhole_59_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389656.490605737781152, 5858767.472956065088511 ], [ 1389681.956975018838421, 5858724.49639992788434 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E39", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 968.70001220703125, "elevtn_dn": 976.10003662109375, "invlev_up": 966.20001220703125, "invlev_dn": 973.60003662109375, "manhole_up": "manhole_59_generated", "manhole_dn": "manhole_60_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389681.956975018838421, 5858724.49639992788434 ], [ 1389708.407580326776952, 5858682.115747822448611 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E40", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 976.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 973.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_60_generated", "manhole_dn": "manhole_61_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389708.407580326776952, 5858682.115747822448611 ], [ 1389734.858185634715483, 5858639.735095717012882 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E41", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 980.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_61_generated", "manhole_dn": "manhole_62_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389734.858185634715483, 5858639.735095717012882 ], [ 1389761.308790942654014, 5858597.354443610645831 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E42", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 980.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_62_generated", "manhole_dn": "manhole_63_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389761.308790942654014, 5858597.354443610645831 ], [ 1389787.759396250825375, 5858554.973791505210102 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E43", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 993.29998779296875, "invlev_up": 980.60003662109375, "invlev_dn": 990.79998779296875, "manhole_up": "manhole_63_generated", "manhole_dn": "manhole_64_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389787.759396250825375, 5858554.973791505210102 ], [ 1389814.210001558763906, 5858512.593139399774373 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E44", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 993.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 990.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_64_generated", "manhole_dn": "manhole_65_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389814.210001558763906, 5858512.593139399774373 ], [ 1389840.660606866702437, 5858470.212487293407321 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E45", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 995.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_65_generated", "manhole_dn": "manhole_66_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389840.660606866702437, 5858470.212487293407321 ], [ 1389867.111212174640968, 5858427.831835187971592 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E46", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 995.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_66_generated", "manhole_dn": "manhole_67_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389867.111212174640968, 5858427.831835187971592 ], [ 1389911.240854029776528, 5858417.074701879173517 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E47", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 1006.2000122070312, "invlev_up": 995.79998779296875, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_67_generated", "manhole_dn": "manhole_68_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389911.240854029776528, 5858417.074701879173517 ], [ 1389940.226093058940023, 5858455.739661679603159 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E48", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1006.2000122070312, "invlev_up": 1003.7000122070312, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_68_generated", "manhole_dn": "manhole_69_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389940.226093058940023, 5858455.739661679603159 ], [ 1389959.842267287895083, 5858501.684845351614058 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E49", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1006.2000122070312, "invlev_up": 1003.7000122070312, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_69_generated", "manhole_dn": "manhole_70_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389959.842267287895083, 5858501.684845351614058 ], [ 1389983.028926897095516, 5858544.760824581608176 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E50", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1036.9000244140625, "invlev_up": 1003.7000122070312, "invlev_dn": 1034.4000244140625, "manhole_up": "manhole_70_generated", "manhole_dn": "manhole_71_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389983.028926897095516, 5858544.760824581608176 ], [ 1390026.879799408372492, 5858567.986969069577754 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E51", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1036.9000244140625, "elevtn_dn": 1036.9000244140625, "invlev_up": 1034.4000244140625, "invlev_dn": 1034.4000244140625, "manhole_up": "manhole_71_generated", "manhole_dn": "manhole_72_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390026.879799408372492, 5858567.986969069577754 ], [ 1390075.455719914287329, 5858577.981817713007331 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E52", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1036.9000244140625, "elevtn_dn": 1032.9000244140625, "invlev_up": 1034.4000244140625, "invlev_dn": 1030.4000244140625, "manhole_up": "manhole_72_generated", "manhole_dn": "manhole_73_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390075.455719914287329, 5858577.981817713007331 ], [ 1390124.934819511603564, 5858584.860858413390815 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E53", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1032.9000244140625, "elevtn_dn": 1032.9000244140625, "invlev_up": 1030.4000244140625, "invlev_dn": 1030.4000244140625, "manhole_up": "manhole_73_generated", "manhole_dn": "manhole_74_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390124.934819511603564, 5858584.860858413390815 ], [ 1390174.385966305155307, 5858591.894069475121796 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E54", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1032.9000244140625, "elevtn_dn": 1016.6000366210938, "invlev_up": 1030.4000244140625, "invlev_dn": 1014.1000366210938, "manhole_up": "manhole_74_generated", "manhole_dn": "manhole_75_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390174.385966305155307, 5858591.894069475121796 ], [ 1390224.28731826832518, 5858594.262458441779017 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E55", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1016.6000366210938, "elevtn_dn": 1016.6000366210938, "invlev_up": 1014.1000366210938, "invlev_dn": 1014.1000366210938, "manhole_up": "manhole_75_generated", "manhole_dn": "manhole_76_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390224.28731826832518, 5858594.262458441779017 ], [ 1390273.630285855382681, 5858589.561945637688041 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E56", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1016.6000366210938, "elevtn_dn": 1012.1000366210938, "invlev_up": 1014.1000366210938, "invlev_dn": 1009.6000366210938, "manhole_up": "manhole_76_generated", "manhole_dn": "manhole_77_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390273.630285855382681, 5858589.561945637688041 ], [ 1390322.239480242831632, 5858578.072306710295379 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E57", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1012.1000366210938, "elevtn_dn": 1012.1000366210938, "invlev_up": 1009.6000366210938, "invlev_dn": 1009.6000366210938, "manhole_up": "manhole_77_generated", "manhole_dn": "manhole_78_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390322.239480242831632, 5858578.072306710295379 ], [ 1390371.99352877959609, 5858575.309522898867726 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E58", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1012.1000366210938, "elevtn_dn": 1011.7000122070312, "invlev_up": 1009.6000366210938, "invlev_dn": 1009.2000122070312, "manhole_up": "manhole_78_generated", "manhole_dn": "manhole_79_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390371.99352877959609, 5858575.309522898867726 ], [ 1390419.13544210139662, 5858559.59311543405056 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E59", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1011.7000122070312, "elevtn_dn": 981.5, "invlev_up": 1009.2000122070312, "invlev_dn": 979.0, "manhole_up": "manhole_79_generated", "manhole_dn": "manhole_80_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390419.13544210139662, 5858559.59311543405056 ], [ 1390453.401623640675098, 5858524.246223840862513 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E60", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 981.5, "elevtn_dn": 995.70001220703125, "invlev_up": 979.0, "invlev_dn": 993.20001220703125, "manhole_up": "manhole_80_generated", "manhole_dn": "manhole_81_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390453.401623640675098, 5858524.246223840862513 ], [ 1390496.749499944737181, 5858504.780008735135198 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E61", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 995.70001220703125, "elevtn_dn": 995.70001220703125, "invlev_up": 993.20001220703125, "invlev_dn": 993.20001220703125, "manhole_up": "manhole_81_generated", "manhole_dn": "manhole_82_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390496.749499944737181, 5858504.780008735135198 ], [ 1390546.470755147282034, 5858499.993151630274951 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E62", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 995.70001220703125, "elevtn_dn": 1005.9000244140625, "invlev_up": 993.20001220703125, "invlev_dn": 1003.4000244140625, "manhole_up": "manhole_82_generated", "manhole_dn": "manhole_83_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390546.470755147282034, 5858499.993151630274951 ], [ 1390596.395264241611585, 5858498.177226040512323 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E63", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1005.9000244140625, "elevtn_dn": 1005.9000244140625, "invlev_up": 1003.4000244140625, "invlev_dn": 1003.4000244140625, "manhole_up": "manhole_83_generated", "manhole_dn": "manhole_84_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390596.395264241611585, 5858498.177226040512323 ], [ 1390646.319773336173967, 5858496.361300451681018 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E64", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1005.9000244140625, "elevtn_dn": 1013.6000366210938, "invlev_up": 1003.4000244140625, "invlev_dn": 1011.1000366210938, "manhole_up": "manhole_84_generated", "manhole_dn": "manhole_85_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390646.319773336173967, 5858496.361300451681018 ], [ 1390696.244282430503517, 5858494.545374862849712 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E65", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1013.6000366210938, "elevtn_dn": 1013.6000366210938, "invlev_up": 1011.1000366210938, "invlev_dn": 1011.1000366210938, "manhole_up": "manhole_85_generated", "manhole_dn": "manhole_86_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390696.244282430503517, 5858494.545374862849712 ], [ 1390746.168791524833068, 5858492.729449273087084 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E66", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1013.6000366210938, "elevtn_dn": 1019.1000366210938, "invlev_up": 1011.1000366210938, "invlev_dn": 1016.6000366210938, "manhole_up": "manhole_86_generated", "manhole_dn": "manhole_87_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390746.168791524833068, 5858492.729449273087084 ], [ 1390796.09330061939545, 5858490.913523684255779 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E67", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1019.1000366210938, "elevtn_dn": 1025.800048828125, "invlev_up": 1016.6000366210938, "invlev_dn": 1023.300048828125, "manhole_up": "manhole_87_generated", "manhole_dn": "manhole_88_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390796.09330061939545, 5858490.913523684255779 ], [ 1390846.017809713725001, 5858489.097598095424473 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E68", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1025.800048828125, "elevtn_dn": 1025.800048828125, "invlev_up": 1023.300048828125, "invlev_dn": 1023.300048828125, "manhole_up": "manhole_88_generated", "manhole_dn": "manhole_89_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390846.017809713725001, 5858489.097598095424473 ], [ 1390895.942318808054551, 5858487.281672505661845 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E69", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1025.800048828125, "elevtn_dn": 1029.2000732421875, "invlev_up": 1023.300048828125, "invlev_dn": 1026.7000732421875, "manhole_up": "manhole_89_generated", "manhole_dn": "manhole_90_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390895.942318808054551, 5858487.281672505661845 ], [ 1390945.364988021552563, 5858492.061225635930896 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E70", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1029.2000732421875, "elevtn_dn": 1029.2000732421875, "invlev_up": 1026.7000732421875, "invlev_dn": 1026.7000732421875, "manhole_up": "manhole_90_generated", "manhole_dn": "manhole_91_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390945.364988021552563, 5858492.061225635930896 ], [ 1390994.440001817885786, 5858501.409873396158218 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E71", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1029.2000732421875, "elevtn_dn": 1033.2000732421875, "invlev_up": 1026.7000732421875, "invlev_dn": 1030.7000732421875, "manhole_up": "manhole_91_generated", "manhole_dn": "manhole_92_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390994.440001817885786, 5858501.409873396158218 ], [ 1391040.341196772176772, 5858520.979841153137386 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E72", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1033.2000732421875, "elevtn_dn": 1033.2000732421875, "invlev_up": 1030.7000732421875, "invlev_dn": 1030.7000732421875, "manhole_up": "manhole_92_generated", "manhole_dn": "manhole_93_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391040.341196772176772, 5858520.979841153137386 ], [ 1391086.683747049886733, 5858538.717575071379542 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E73", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1033.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1030.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_93_generated", "manhole_dn": "manhole_94_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391086.683747049886733, 5858538.717575071379542 ], [ 1391131.822940095094964, 5858523.93243224080652 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E74", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_94_generated", "manhole_dn": "manhole_95_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391131.822940095094964, 5858523.93243224080652 ], [ 1391153.157672074623406, 5858479.460670891217887 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E75", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_95_generated", "manhole_dn": "manhole_96_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391153.157672074623406, 5858479.460670891217887 ], [ 1391192.49590603238903, 5858451.67839205916971 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E76", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1044.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1041.7000732421875, "manhole_up": "manhole_96_generated", "manhole_dn": "manhole_97_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391192.49590603238903, 5858451.67839205916971 ], [ 1391240.64117361814715, 5858438.460245226509869 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E77", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1044.2000732421875, "elevtn_dn": 1044.2000732421875, "invlev_up": 1041.7000732421875, "invlev_dn": 1041.7000732421875, "manhole_up": "manhole_97_generated", "manhole_dn": "manhole_98_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391240.64117361814715, 5858438.460245226509869 ], [ 1391289.211760010803118, 5858426.770406410098076 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E78", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1044.2000732421875, "elevtn_dn": 1060.0999755859375, "invlev_up": 1041.7000732421875, "invlev_dn": 1057.5999755859375, "manhole_up": "manhole_98_generated", "manhole_dn": "manhole_99_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391289.211760010803118, 5858426.770406410098076 ], [ 1391337.782346403226256, 5858415.080567593686283 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E79", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1060.0999755859375, "elevtn_dn": 1023.0, "invlev_up": 1057.5999755859375, "invlev_dn": 1020.5, "manhole_up": "manhole_99_generated", "manhole_dn": "manhole_100_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391337.782346403226256, 5858415.080567593686283 ], [ 1391386.352932795882225, 5858403.390728777274489 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E80", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1023.0, "elevtn_dn": 1032.7000732421875, "invlev_up": 1020.5, "invlev_dn": 1030.2000732421875, "manhole_up": "manhole_100_generated", "manhole_dn": "manhole_101_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391386.352932795882225, 5858403.390728777274489 ], [ 1391434.923519188305363, 5858391.700889961794019 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E81", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1032.7000732421875, "elevtn_dn": 1032.7000732421875, "invlev_up": 1030.2000732421875, "invlev_dn": 1030.2000732421875, "manhole_up": "manhole_101_generated", "manhole_dn": "manhole_102_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391434.923519188305363, 5858391.700889961794019 ], [ 1391483.494105580961332, 5858380.011051145382226 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E82", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1032.7000732421875, "elevtn_dn": 1040.7000732421875, "invlev_up": 1030.2000732421875, "invlev_dn": 1038.2000732421875, "manhole_up": "manhole_102_generated", "manhole_dn": "manhole_103_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391483.494105580961332, 5858380.011051145382226 ], [ 1391532.464345134794712, 5858375.802092345431447 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E83", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1040.7000732421875, "elevtn_dn": 1040.7000732421875, "invlev_up": 1038.2000732421875, "invlev_dn": 1038.2000732421875, "manhole_up": "manhole_103_generated", "manhole_dn": "manhole_104_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391532.464345134794712, 5858375.802092345431447 ], [ 1391579.680508555145934, 5858389.753166117705405 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E84", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1040.7000732421875, "elevtn_dn": 1094.5999755859375, "invlev_up": 1038.2000732421875, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_104_generated", "manhole_dn": "manhole_105_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391579.680508555145934, 5858389.753166117705405 ], [ 1391615.043221722124144, 5858422.374543751589954 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E85", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1094.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_105_generated", "manhole_dn": "manhole_106_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391615.043221722124144, 5858422.374543751589954 ], [ 1391633.654095822479576, 5858468.206737855449319 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E86", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1094.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_106_generated", "manhole_dn": "manhole_107_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391633.654095822479576, 5858468.206737855449319 ], [ 1391675.556871910346672, 5858492.042518986389041 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E87", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1100.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1098.0999755859375, "manhole_up": "manhole_107_generated", "manhole_dn": "manhole_108_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391675.556871910346672, 5858492.042518986389041 ], [ 1391725.165284683462232, 5858493.223410680890083 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E88", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1100.5999755859375, "elevtn_dn": 1092.7000732421875, "invlev_up": 1098.0999755859375, "invlev_dn": 1090.2000732421875, "manhole_up": "manhole_108_generated", "manhole_dn": "manhole_109_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391725.165284683462232, 5858493.223410680890083 ], [ 1391774.025632579578087, 5858482.968163449317217 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E89", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1092.7000732421875, "elevtn_dn": 1092.7000732421875, "invlev_up": 1090.2000732421875, "invlev_dn": 1090.2000732421875, "manhole_up": "manhole_109_generated", "manhole_dn": "manhole_110_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391774.025632579578087, 5858482.968163449317217 ], [ 1391822.748904443578795, 5858472.800456050783396 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E90", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1092.7000732421875, "elevtn_dn": 1086.5, "invlev_up": 1090.2000732421875, "invlev_dn": 1084.0, "manhole_up": "manhole_110_generated", "manhole_dn": "manhole_111_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391822.748904443578795, 5858472.800456050783396 ], [ 1391872.520155652426183, 5858474.254766616038978 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E91", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1086.5, "elevtn_dn": 1086.5, "invlev_up": 1084.0, "invlev_dn": 1084.0, "manhole_up": "manhole_111_generated", "manhole_dn": "manhole_112_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391872.520155652426183, 5858474.254766616038978 ], [ 1391922.32820742437616, 5858478.116394865326583 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E92", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1086.5, "elevtn_dn": 1097.300048828125, "invlev_up": 1084.0, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_112_generated", "manhole_dn": "manhole_113_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391922.32820742437616, 5858478.116394865326583 ], [ 1391972.136259196558967, 5858481.978023114614189 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E93", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_113_generated", "manhole_dn": "manhole_114_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391972.136259196558967, 5858481.978023114614189 ], [ 1392014.088137687649578, 5858507.265420926734805 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E94", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_114_generated", "manhole_dn": "manhole_115_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392014.088137687649578, 5858507.265420926734805 ], [ 1392052.00577615830116, 5858538.949620860628784 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E95", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_115_generated", "manhole_dn": "manhole_116_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392052.00577615830116, 5858538.949620860628784 ], [ 1392100.993319420609623, 5858548.746293722651899 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E96", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1135.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1132.800048828125, "manhole_up": "manhole_116_generated", "manhole_dn": "manhole_117_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392100.993319420609623, 5858548.746293722651899 ], [ 1392149.980862683150917, 5858558.542966585606337 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E97", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1135.300048828125, "elevtn_dn": 1135.300048828125, "invlev_up": 1132.800048828125, "invlev_dn": 1132.800048828125, "manhole_up": "manhole_117_generated", "manhole_dn": "manhole_118_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392149.980862683150917, 5858558.542966585606337 ], [ 1392198.767287699971348, 5858569.25206732749939 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E98", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1135.300048828125, "elevtn_dn": 1137.5999755859375, "invlev_up": 1132.800048828125, "invlev_dn": 1135.0999755859375, "manhole_up": "manhole_118_generated", "manhole_dn": "manhole_119_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392198.767287699971348, 5858569.25206732749939 ], [ 1392247.333906656363979, 5858580.958378325216472 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E99", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1137.5999755859375, "elevtn_dn": 1137.5999755859375, "invlev_up": 1135.0999755859375, "invlev_dn": 1135.0999755859375, "manhole_up": "manhole_119_generated", "manhole_dn": "manhole_120_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392247.333906656363979, 5858580.958378325216472 ], [ 1392295.900525612989441, 5858592.664689323864877 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E100", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1137.5999755859375, "elevtn_dn": 1145.0999755859375, "invlev_up": 1135.0999755859375, "invlev_dn": 1142.5999755859375, "manhole_up": "manhole_120_generated", "manhole_dn": "manhole_121_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392295.900525612989441, 5858592.664689323864877 ], [ 1392344.467144569614902, 5858604.371000322513282 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E101", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1145.0999755859375, "elevtn_dn": 1145.0999755859375, "invlev_up": 1142.5999755859375, "invlev_dn": 1142.5999755859375, "manhole_up": "manhole_121_generated", "manhole_dn": "manhole_122_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392344.467144569614902, 5858604.371000322513282 ], [ 1392389.908255772199482, 5858624.575613909401 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E102", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1145.0999755859375, "elevtn_dn": 1140.5, "invlev_up": 1142.5999755859375, "invlev_dn": 1138.0, "manhole_up": "manhole_122_generated", "manhole_dn": "manhole_123_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392389.908255772199482, 5858624.575613909401 ], [ 1392425.081700494978577, 5858659.315580372698605 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E103", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1140.5, "elevtn_dn": 1169.300048828125, "invlev_up": 1138.0, "invlev_dn": 1166.800048828125, "manhole_up": "manhole_123_generated", "manhole_dn": "manhole_124_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392425.081700494978577, 5858659.315580372698605 ], [ 1392458.203119478421286, 5858696.715123130939901 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E104", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1169.300048828125, "elevtn_dn": 1169.300048828125, "invlev_up": 1166.800048828125, "invlev_dn": 1166.800048828125, "manhole_up": "manhole_124_generated", "manhole_dn": "manhole_125_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392458.203119478421286, 5858696.715123130939901 ], [ 1392491.324538461863995, 5858734.114665890112519 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E105", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1169.300048828125, "elevtn_dn": 1165.5, "invlev_up": 1166.800048828125, "invlev_dn": 1163.0, "manhole_up": "manhole_125_generated", "manhole_dn": "manhole_126_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392491.324538461863995, 5858734.114665890112519 ], [ 1392528.963966277893633, 5858766.460637149401009 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E106", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1165.5, "elevtn_dn": 1165.5, "invlev_up": 1163.0, "invlev_dn": 1163.0, "manhole_up": "manhole_126_generated", "manhole_dn": "manhole_127_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392528.963966277893633, 5858766.460637149401009 ], [ 1392573.284122244687751, 5858789.391092935577035 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E107", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1165.5, "elevtn_dn": 1157.0999755859375, "invlev_up": 1163.0, "invlev_dn": 1154.5999755859375, "manhole_up": "manhole_127_generated", "manhole_dn": "manhole_128_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392573.284122244687751, 5858789.391092935577035 ], [ 1392618.033192394766957, 5858811.600886153057218 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E108", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1157.0999755859375, "elevtn_dn": 1184.800048828125, "invlev_up": 1154.5999755859375, "invlev_dn": 1182.300048828125, "manhole_up": "manhole_128_generated", "manhole_dn": "manhole_129_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392618.033192394766957, 5858811.600886153057218 ], [ 1392666.730896146036685, 5858821.011833874508739 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E109", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1184.800048828125, "elevtn_dn": 1141.2000732421875, "invlev_up": 1182.300048828125, "invlev_dn": 1138.7000732421875, "manhole_up": "manhole_129_generated", "manhole_dn": "manhole_130_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392666.730896146036685, 5858821.011833874508739 ], [ 1392714.397227015113458, 5858809.184477739967406 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E110", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1141.2000732421875, "elevtn_dn": 1141.2000732421875, "invlev_up": 1138.7000732421875, "invlev_dn": 1138.7000732421875, "manhole_up": "manhole_130_generated", "manhole_dn": "manhole_131_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392714.397227015113458, 5858809.184477739967406 ], [ 1392761.799294820055366, 5858794.231293976306915 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E111", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1141.2000732421875, "elevtn_dn": 1137.4000244140625, "invlev_up": 1138.7000732421875, "invlev_dn": 1134.9000244140625, "manhole_up": "manhole_131_generated", "manhole_dn": "manhole_132_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392761.799294820055366, 5858794.231293976306915 ], [ 1392810.095712865469977, 5858797.830352782271802 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E112", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1137.4000244140625, "elevtn_dn": 1137.4000244140625, "invlev_up": 1134.9000244140625, "invlev_dn": 1134.9000244140625, "manhole_up": "manhole_132_generated", "manhole_dn": "manhole_133_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392810.095712865469977, 5858797.830352782271802 ], [ 1392855.660074200481176, 5858817.529770986177027 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E113", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1137.4000244140625, "elevtn_dn": 1169.5, "invlev_up": 1134.9000244140625, "invlev_dn": 1167.0, "manhole_up": "manhole_133_generated", "manhole_dn": "manhole_134_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392855.660074200481176, 5858817.529770986177027 ], [ 1392904.672455, 5858826.347064822912216 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E114", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_134_generated", "manhole_dn": "manhole_135_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392904.672455, 5858826.347064822912216 ], [ 1392949.505032581742853, 5858846.393358059227467 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E115", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_135_generated", "manhole_dn": "manhole_136_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392949.505032581742853, 5858846.393358059227467 ], [ 1392993.956312821945176, 5858868.358838438987732 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E116", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_136_generated", "manhole_dn": "manhole_137_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392993.956312821945176, 5858868.358838438987732 ], [ 1393042.160067020915449, 5858881.479519641026855 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E117", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1162.0, "invlev_up": 1167.0, "invlev_dn": 1159.5, "manhole_up": "manhole_137_generated", "manhole_dn": "manhole_138_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393042.160067020915449, 5858881.479519641026855 ], [ 1393090.363821219652891, 5858894.600200843065977 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E118", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1162.0, "elevtn_dn": 1162.0, "invlev_up": 1159.5, "invlev_dn": 1159.5, "manhole_up": "manhole_138_generated", "manhole_dn": "manhole_139_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393090.363821219652891, 5858894.600200843065977 ], [ 1393138.877780271228403, 5858905.382868006825447 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E119", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1162.0, "elevtn_dn": 1152.0999755859375, "invlev_up": 1159.5, "invlev_dn": 1149.5999755859375, "manhole_up": "manhole_139_generated", "manhole_dn": "manhole_140_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393138.877780271228403, 5858905.382868006825447 ], [ 1393188.835210436256602, 5858905.286093098111451 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E120", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1152.0999755859375, "elevtn_dn": 1152.0999755859375, "invlev_up": 1149.5999755859375, "invlev_dn": 1149.5999755859375, "manhole_up": "manhole_140_generated", "manhole_dn": "manhole_141_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393188.835210436256602, 5858905.286093098111451 ], [ 1393237.248238409170881, 5858916.599204055964947 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E121", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1152.0999755859375, "elevtn_dn": 1147.300048828125, "invlev_up": 1149.5999755859375, "invlev_dn": 1144.800048828125, "manhole_up": "manhole_141_generated", "manhole_dn": "manhole_142_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393237.248238409170881, 5858916.599204055964947 ], [ 1393278.15638761385344, 5858943.766047672368586 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E122", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1147.300048828125, "elevtn_dn": 1182.7000732421875, "invlev_up": 1144.800048828125, "invlev_dn": 1180.2000732421875, "manhole_up": "manhole_142_generated", "manhole_dn": "manhole_143_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393278.15638761385344, 5858943.766047672368586 ], [ 1393316.553906054003164, 5858975.725158606655896 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E123", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1182.7000732421875, "elevtn_dn": 1180.0999755859375, "invlev_up": 1180.2000732421875, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_143_generated", "manhole_dn": "manhole_144_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393316.553906054003164, 5858975.725158606655896 ], [ 1393354.951424494385719, 5859007.684269540011883 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E124", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1180.0999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_144_generated", "manhole_dn": "manhole_145_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393354.951424494385719, 5859007.684269540011883 ], [ 1393393.348942934535444, 5859039.643380474299192 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E125", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1180.0999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_145_generated", "manhole_dn": "manhole_146_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393393.348942934535444, 5859039.643380474299192 ], [ 1393431.746461374685168, 5859071.602491408586502 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E126", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_146_generated", "manhole_dn": "manhole_147_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393431.746461374685168, 5859071.602491408586502 ], [ 1393472.672340910183266, 5859100.089053857140243 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E127", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1200.0999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_147_generated", "manhole_dn": "manhole_148_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393472.672340910183266, 5859100.089053857140243 ], [ 1393507.678647378925234, 5859134.262682756409049 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E128", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1200.0999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_148_generated", "manhole_dn": "manhole_149_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393507.678647378925234, 5859134.262682756409049 ], [ 1393492.637579936999828, 5859179.667013085447252 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E129", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1232.300048828125, "invlev_up": 1200.0999755859375, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_149_generated", "manhole_dn": "manhole_150_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393492.637579936999828, 5859179.667013085447252 ], [ 1393472.727902054553851, 5859225.064155456610024 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E130", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_150_generated", "manhole_dn": "manhole_151_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393472.727902054553851, 5859225.064155456610024 ], [ 1393467.563765458529815, 5859274.587596206925809 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E131", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_151_generated", "manhole_dn": "manhole_152_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393467.563765458529815, 5859274.587596206925809 ], [ 1393473.51405850565061, 5859323.8850102070719 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E132", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_152_generated", "manhole_dn": "manhole_153_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393473.51405850565061, 5859323.8850102070719 ], [ 1393507.773820924572647, 5859356.614802500233054 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E133", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1214.800048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1212.300048828125, "manhole_up": "manhole_153_generated", "manhole_dn": "manhole_154_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393507.773820924572647, 5859356.614802500233054 ], [ 1393555.824224345618859, 5859349.253152369521558 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E134", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1214.800048828125, "elevtn_dn": 1214.800048828125, "invlev_up": 1212.300048828125, "invlev_dn": 1212.300048828125, "manhole_up": "manhole_154_generated", "manhole_dn": "manhole_155_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393555.824224345618859, 5859349.253152369521558 ], [ 1393591.00338595919311, 5859314.794959847815335 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E135", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1214.800048828125, "elevtn_dn": 1191.0999755859375, "invlev_up": 1212.300048828125, "invlev_dn": 1188.5999755859375, "manhole_up": "manhole_155_generated", "manhole_dn": "manhole_156_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393591.00338595919311, 5859314.794959847815335 ], [ 1393633.153639519121498, 5859288.066565420478582 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E136", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1191.0999755859375, "elevtn_dn": 1191.0999755859375, "invlev_up": 1188.5999755859375, "invlev_dn": 1188.5999755859375, "manhole_up": "manhole_156_generated", "manhole_dn": "manhole_157_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393633.153639519121498, 5859288.066565420478582 ], [ 1393673.123904188396409, 5859258.097712650895119 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E137", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1191.0999755859375, "elevtn_dn": 1144.300048828125, "invlev_up": 1188.5999755859375, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_157_generated", "manhole_dn": "manhole_158_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393673.123904188396409, 5859258.097712650895119 ], [ 1393720.523227575467899, 5859244.838272913359106 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E138", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1144.300048828125, "invlev_up": 1141.800048828125, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_158_generated", "manhole_dn": "manhole_159_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393720.523227575467899, 5859244.838272913359106 ], [ 1393765.710014625452459, 5859224.569284616038203 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E139", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1144.300048828125, "invlev_up": 1141.800048828125, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_159_generated", "manhole_dn": "manhole_160_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393765.710014625452459, 5859224.569284616038203 ], [ 1393806.409210936399177, 5859195.609256223775446 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_8_E140", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1112.5, "invlev_up": 1141.800048828125, "invlev_dn": 1110.0, "manhole_up": "manhole_160_generated", "manhole_dn": "manhole_161_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393806.409210936399177, 5859195.609256223775446 ], [ 1393846.866742686368525, 5859166.301538489758968 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1045", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 968.29998779296875, "invlev_up": 965.79998779296875, "invlev_dn": 965.79998779296875, "manhole_up": "manhole_162_generated", "manhole_dn": "manhole_163_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388521.257592596346512, 5855362.027613477781415 ], [ 1388472.030306826578453, 5855370.543775821104646 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1046", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 968.29998779296875, "invlev_up": 965.79998779296875, "invlev_dn": 965.79998779296875, "manhole_up": "manhole_163_generated", "manhole_dn": "manhole_164_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388472.030306826578453, 5855370.543775821104646 ], [ 1388439.000347282737494, 5855407.802592809312046 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1047", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 964.5, "invlev_up": 965.79998779296875, "invlev_dn": 962.0, "manhole_up": "manhole_164_generated", "manhole_dn": "manhole_165_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388439.000347282737494, 5855407.802592809312046 ], [ 1388400.196091859601438, 5855436.014134516008198 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1048", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 964.5, "invlev_up": 962.0, "invlev_dn": 962.0, "manhole_up": "manhole_165_generated", "manhole_dn": "manhole_166_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388400.196091859601438, 5855436.014134516008198 ], [ 1388351.33823574683629, 5855446.634319253265858 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1049", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 981.9000244140625, "invlev_up": 962.0, "invlev_dn": 979.4000244140625, "manhole_up": "manhole_166_generated", "manhole_dn": "manhole_167_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388351.33823574683629, 5855446.634319253265858 ], [ 1388301.961881892289966, 5855453.847477887757123 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1050", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 981.9000244140625, "elevtn_dn": 981.9000244140625, "invlev_up": 979.4000244140625, "invlev_dn": 979.4000244140625, "manhole_up": "manhole_167_generated", "manhole_dn": "manhole_168_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388301.961881892289966, 5855453.847477887757123 ], [ 1388252.297577269142494, 5855451.260453455150127 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1051", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 981.9000244140625, "elevtn_dn": 973.70001220703125, "invlev_up": 979.4000244140625, "invlev_dn": 971.20001220703125, "manhole_up": "manhole_168_generated", "manhole_dn": "manhole_169_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388252.297577269142494, 5855451.260453455150127 ], [ 1388202.479659734526649, 5855455.508814659900963 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1052", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 973.70001220703125, "elevtn_dn": 961.70001220703125, "invlev_up": 971.20001220703125, "invlev_dn": 959.20001220703125, "manhole_up": "manhole_169_generated", "manhole_dn": "manhole_170_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388202.479659734526649, 5855455.508814659900963 ], [ 1388152.683455461403355, 5855460.015516467392445 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1053", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 961.70001220703125, "elevtn_dn": 961.70001220703125, "invlev_up": 959.20001220703125, "invlev_dn": 959.20001220703125, "manhole_up": "manhole_170_generated", "manhole_dn": "manhole_171_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388152.683455461403355, 5855460.015516467392445 ], [ 1388104.622611842118204, 5855473.253733876161277 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1054", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 961.70001220703125, "elevtn_dn": 945.79998779296875, "invlev_up": 959.20001220703125, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_171_generated", "manhole_dn": "manhole_172_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388104.622611842118204, 5855473.253733876161277 ], [ 1388057.00563437351957, 5855488.445189393125474 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1055", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 945.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_172_generated", "manhole_dn": "manhole_173_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388057.00563437351957, 5855488.445189393125474 ], [ 1388011.292356542311609, 5855508.700276436284184 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1056", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 945.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_173_generated", "manhole_dn": "manhole_174_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388011.292356542311609, 5855508.700276436284184 ], [ 1387969.221702651120722, 5855535.246164590120316 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1057", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 930.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 928.29998779296875, "manhole_up": "manhole_174_generated", "manhole_dn": "manhole_175_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.221702651120722, 5855535.246164590120316 ], [ 1387935.863196024205536, 5855572.491061648353934 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1058", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 930.79998779296875, "elevtn_dn": 957.10003662109375, "invlev_up": 928.29998779296875, "invlev_dn": 954.60003662109375, "manhole_up": "manhole_175_generated", "manhole_dn": "manhole_176_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387935.863196024205536, 5855572.491061648353934 ], [ 1387904.610231971368194, 5855611.432584651745856 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1059", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.10003662109375, "elevtn_dn": 947.4000244140625, "invlev_up": 954.60003662109375, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_176_generated", "manhole_dn": "manhole_177_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387904.610231971368194, 5855611.432584651745856 ], [ 1387869.335365027422085, 5855646.852918352000415 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1060", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 947.4000244140625, "invlev_up": 944.9000244140625, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_177_generated", "manhole_dn": "manhole_178_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387869.335365027422085, 5855646.852918352000415 ], [ 1387831.783288773847744, 5855679.735664095729589 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1061", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 947.4000244140625, "invlev_up": 944.9000244140625, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_178_generated", "manhole_dn": "manhole_179_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387831.783288773847744, 5855679.735664095729589 ], [ 1387791.509416193468496, 5855708.923279576934874 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1062", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 933.29998779296875, "invlev_up": 944.9000244140625, "invlev_dn": 930.79998779296875, "manhole_up": "manhole_179_generated", "manhole_dn": "manhole_180_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387791.509416193468496, 5855708.923279576934874 ], [ 1387742.459816947113723, 5855717.213657722808421 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1063", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 933.29998779296875, "elevtn_dn": 933.29998779296875, "invlev_up": 930.79998779296875, "invlev_dn": 930.79998779296875, "manhole_up": "manhole_180_generated", "manhole_dn": "manhole_181_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387742.459816947113723, 5855717.213657722808421 ], [ 1387692.500367184402421, 5855718.495403698645532 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1064", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 933.29998779296875, "elevtn_dn": 911.10003662109375, "invlev_up": 930.79998779296875, "invlev_dn": 908.60003662109375, "manhole_up": "manhole_181_generated", "manhole_dn": "manhole_182_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387692.500367184402421, 5855718.495403698645532 ], [ 1387642.500798417022452, 5855718.61967874225229 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1065", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 911.10003662109375, "elevtn_dn": 887.70001220703125, "invlev_up": 908.60003662109375, "invlev_dn": 885.20001220703125, "manhole_up": "manhole_182_generated", "manhole_dn": "manhole_183_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387642.500798417022452, 5855718.61967874225229 ], [ 1387592.501229649642482, 5855718.743953784927726 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1066", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 887.70001220703125, "elevtn_dn": 887.70001220703125, "invlev_up": 885.20001220703125, "invlev_dn": 885.20001220703125, "manhole_up": "manhole_183_generated", "manhole_dn": "manhole_184_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387592.501229649642482, 5855718.743953784927726 ], [ 1387542.501660882262513, 5855718.868228827603161 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1067", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 887.70001220703125, "elevtn_dn": 902.9000244140625, "invlev_up": 885.20001220703125, "invlev_dn": 900.4000244140625, "manhole_up": "manhole_184_generated", "manhole_dn": "manhole_185_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387542.501660882262513, 5855718.868228827603161 ], [ 1387492.651409652316943, 5855720.815255363471806 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1068", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 902.9000244140625, "elevtn_dn": 902.9000244140625, "invlev_up": 900.4000244140625, "invlev_dn": 900.4000244140625, "manhole_up": "manhole_185_generated", "manhole_dn": "manhole_186_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387492.651409652316943, 5855720.815255363471806 ], [ 1387448.867236748570576, 5855742.752516686916351 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1069", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 902.9000244140625, "elevtn_dn": 886.20001220703125, "invlev_up": 900.4000244140625, "invlev_dn": 883.70001220703125, "manhole_up": "manhole_186_generated", "manhole_dn": "manhole_187_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387448.867236748570576, 5855742.752516686916351 ], [ 1387402.432745414320379, 5855761.091833713464439 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1070", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 886.20001220703125, "elevtn_dn": 886.20001220703125, "invlev_up": 883.70001220703125, "invlev_dn": 883.70001220703125, "manhole_up": "manhole_187_generated", "manhole_dn": "manhole_188_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387402.432745414320379, 5855761.091833713464439 ], [ 1387355.687973388005048, 5855778.837216476909816 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1071", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 886.20001220703125, "elevtn_dn": 879.4000244140625, "invlev_up": 883.70001220703125, "invlev_dn": 876.9000244140625, "manhole_up": "manhole_188_generated", "manhole_dn": "manhole_189_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387355.687973388005048, 5855778.837216476909816 ], [ 1387308.943201361689717, 5855796.582599240355194 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1072", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 879.4000244140625, "elevtn_dn": 879.4000244140625, "invlev_up": 876.9000244140625, "invlev_dn": 876.9000244140625, "manhole_up": "manhole_189_generated", "manhole_dn": "manhole_190_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387308.943201361689717, 5855796.582599240355194 ], [ 1387262.861613623332232, 5855815.656713440082967 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1073", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 879.4000244140625, "elevtn_dn": 873.29998779296875, "invlev_up": 876.9000244140625, "invlev_dn": 870.79998779296875, "manhole_up": "manhole_190_generated", "manhole_dn": "manhole_191_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387262.861613623332232, 5855815.656713440082967 ], [ 1387224.059019178850576, 5855846.996291697025299 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1074", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 873.29998779296875, "elevtn_dn": 938.9000244140625, "invlev_up": 870.79998779296875, "invlev_dn": 936.4000244140625, "manhole_up": "manhole_191_generated", "manhole_dn": "manhole_192_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387224.059019178850576, 5855846.996291697025299 ], [ 1387180.719124856637791, 5855870.194651792757213 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1075", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 938.9000244140625, "elevtn_dn": 932.79998779296875, "invlev_up": 936.4000244140625, "invlev_dn": 930.29998779296875, "manhole_up": "manhole_192_generated", "manhole_dn": "manhole_193_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387180.719124856637791, 5855870.194651792757213 ], [ 1387131.003996425773948, 5855874.064550469629467 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1076", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 932.79998779296875, "elevtn_dn": 932.79998779296875, "invlev_up": 930.29998779296875, "invlev_dn": 930.29998779296875, "manhole_up": "manhole_193_generated", "manhole_dn": "manhole_194_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387131.003996425773948, 5855874.064550469629467 ], [ 1387081.098878284916282, 5855871.158613862469792 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1077", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 932.79998779296875, "elevtn_dn": 916.79998779296875, "invlev_up": 930.29998779296875, "invlev_dn": 914.29998779296875, "manhole_up": "manhole_194_generated", "manhole_dn": "manhole_195_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387081.098878284916282, 5855871.158613862469792 ], [ 1387031.198060098802671, 5855868.015261265449226 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1078", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 916.79998779296875, "elevtn_dn": 916.79998779296875, "invlev_up": 914.29998779296875, "invlev_dn": 914.29998779296875, "manhole_up": "manhole_195_generated", "manhole_dn": "manhole_196_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387031.198060098802671, 5855868.015261265449226 ], [ 1386981.297241912456229, 5855864.871908667497337 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1079", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 916.79998779296875, "elevtn_dn": 891.79998779296875, "invlev_up": 914.29998779296875, "invlev_dn": 889.29998779296875, "manhole_up": "manhole_196_generated", "manhole_dn": "manhole_197_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386981.297241912456229, 5855864.871908667497337 ], [ 1386931.47147326474078, 5855860.718019699677825 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1080", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 891.79998779296875, "elevtn_dn": 891.79998779296875, "invlev_up": 889.29998779296875, "invlev_dn": 889.29998779296875, "manhole_up": "manhole_197_generated", "manhole_dn": "manhole_198_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386931.47147326474078, 5855860.718019699677825 ], [ 1386881.600663758814335, 5855857.577047945931554 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1081", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 891.79998779296875, "elevtn_dn": 857.10003662109375, "invlev_up": 889.29998779296875, "invlev_dn": 854.60003662109375, "manhole_up": "manhole_198_generated", "manhole_dn": "manhole_199_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386881.600663758814335, 5855857.577047945931554 ], [ 1386832.545593914575875, 5855864.100992278195918 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1082", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 857.10003662109375, "elevtn_dn": 857.10003662109375, "invlev_up": 854.60003662109375, "invlev_dn": 854.60003662109375, "manhole_up": "manhole_199_generated", "manhole_dn": "manhole_200_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386832.545593914575875, 5855864.100992278195918 ], [ 1386787.06764860637486, 5855884.403254445642233 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1083", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 857.10003662109375, "elevtn_dn": 821.29998779296875, "invlev_up": 854.60003662109375, "invlev_dn": 818.79998779296875, "manhole_up": "manhole_200_generated", "manhole_dn": "manhole_201_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386787.06764860637486, 5855884.403254445642233 ], [ 1386748.278358669718727, 5855915.544586268253624 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1084", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 821.29998779296875, "elevtn_dn": 821.29998779296875, "invlev_up": 818.79998779296875, "invlev_dn": 818.79998779296875, "manhole_up": "manhole_201_generated", "manhole_dn": "manhole_202_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386748.278358669718727, 5855915.544586268253624 ], [ 1386721.155419877264649, 5855957.124278785660863 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1085", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 821.29998779296875, "elevtn_dn": 866.0, "invlev_up": 818.79998779296875, "invlev_dn": 863.5, "manhole_up": "manhole_202_generated", "manhole_dn": "manhole_203_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386721.155419877264649, 5855957.124278785660863 ], [ 1386707.750365849817172, 5856004.850832763127983 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1086", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 866.0, "invlev_up": 863.5, "invlev_dn": 863.5, "manhole_up": "manhole_203_generated", "manhole_dn": "manhole_204_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386707.750365849817172, 5856004.850832763127983 ], [ 1386699.832475832896307, 5856054.133603978902102 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1087", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 866.0, "invlev_up": 863.5, "invlev_dn": 863.5, "manhole_up": "manhole_204_generated", "manhole_dn": "manhole_205_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386699.832475832896307, 5856054.133603978902102 ], [ 1386697.095561265014112, 5856103.986880083568394 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1088", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 884.79998779296875, "invlev_up": 863.5, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_205_generated", "manhole_dn": "manhole_206_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386697.095561265014112, 5856103.986880083568394 ], [ 1386699.401158998254687, 5856153.933416903018951 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1089", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 884.79998779296875, "invlev_up": 882.29998779296875, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_206_generated", "manhole_dn": "manhole_207_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386699.401158998254687, 5856153.933416903018951 ], [ 1386715.699191288091242, 5856201.197657831013203 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1090", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 884.79998779296875, "invlev_up": 882.29998779296875, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_207_generated", "manhole_dn": "manhole_208_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386715.699191288091242, 5856201.197657831013203 ], [ 1386741.121203816728666, 5856244.100116757676005 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1091", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 915.9000244140625, "invlev_up": 882.29998779296875, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_208_generated", "manhole_dn": "manhole_209_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386741.121203816728666, 5856244.100116757676005 ], [ 1386774.051378605188802, 5856281.577651324681938 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1092", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_209_generated", "manhole_dn": "manhole_210_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386774.051378605188802, 5856281.577651324681938 ], [ 1386811.583791718119755, 5856314.587093180976808 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1093", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_210_generated", "manhole_dn": "manhole_211_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386811.583791718119755, 5856314.587093180976808 ], [ 1386839.378956499742344, 5856356.087350118905306 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1094", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_211_generated", "manhole_dn": "manhole_212_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386839.378956499742344, 5856356.087350118905306 ], [ 1386855.653891535941511, 5856403.364181768149137 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1095", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_212_generated", "manhole_dn": "manhole_213_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386855.653891535941511, 5856403.364181768149137 ], [ 1386875.714553950354457, 5856449.116945925168693 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1096", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_213_generated", "manhole_dn": "manhole_214_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386875.714553950354457, 5856449.116945925168693 ], [ 1386912.179653002182022, 5856482.939191372133791 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1097", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_214_generated", "manhole_dn": "manhole_215_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386912.179653002182022, 5856482.939191372133791 ], [ 1386944.191176384687424, 5856520.270725904032588 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1098", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 911.79998779296875, "invlev_up": 907.4000244140625, "invlev_dn": 909.29998779296875, "manhole_up": "manhole_215_generated", "manhole_dn": "manhole_216_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386944.191176384687424, 5856520.270725904032588 ], [ 1386964.188513180473819, 5856566.025075756013393 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1099", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 911.79998779296875, "elevtn_dn": 911.79998779296875, "invlev_up": 909.29998779296875, "invlev_dn": 909.29998779296875, "manhole_up": "manhole_216_generated", "manhole_dn": "manhole_217_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386964.188513180473819, 5856566.025075756013393 ], [ 1386998.825215350603685, 5856599.261941562406719 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1100", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 911.79998779296875, "elevtn_dn": 932.0, "invlev_up": 909.29998779296875, "invlev_dn": 929.5, "manhole_up": "manhole_217_generated", "manhole_dn": "manhole_218_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386998.825215350603685, 5856599.261941562406719 ], [ 1387044.828526843106374, 5856618.849377661012113 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1101", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 932.0, "invlev_up": 929.5, "invlev_dn": 929.5, "manhole_up": "manhole_218_generated", "manhole_dn": "manhole_219_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387044.828526843106374, 5856618.849377661012113 ], [ 1387090.831838335609064, 5856638.43681376054883 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1102", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 949.9000244140625, "invlev_up": 929.5, "invlev_dn": 947.4000244140625, "manhole_up": "manhole_219_generated", "manhole_dn": "manhole_220_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387090.831838335609064, 5856638.43681376054883 ], [ 1387136.835149827878922, 5856658.024249859154224 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1103", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 949.9000244140625, "elevtn_dn": 924.4000244140625, "invlev_up": 947.4000244140625, "invlev_dn": 921.9000244140625, "manhole_up": "manhole_220_generated", "manhole_dn": "manhole_221_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387136.835149827878922, 5856658.024249859154224 ], [ 1387178.671980312326923, 5856685.128790453076363 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1104", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 924.4000244140625, "elevtn_dn": 924.4000244140625, "invlev_up": 921.9000244140625, "invlev_dn": 921.9000244140625, "manhole_up": "manhole_221_generated", "manhole_dn": "manhole_222_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387178.671980312326923, 5856685.128790453076363 ], [ 1387217.700535611249506, 5856716.320352808572352 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1105", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 924.4000244140625, "elevtn_dn": 940.0, "invlev_up": 921.9000244140625, "invlev_dn": 937.5, "manhole_up": "manhole_222_generated", "manhole_dn": "manhole_223_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387217.700535611249506, 5856716.320352808572352 ], [ 1387252.016686553368345, 5856752.649443434551358 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1106", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 940.0, "elevtn_dn": 940.0, "invlev_up": 937.5, "invlev_dn": 937.5, "manhole_up": "manhole_223_generated", "manhole_dn": "manhole_224_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387252.016686553368345, 5856752.649443434551358 ], [ 1387284.798919493798167, 5856790.190159549936652 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1107", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 940.0, "elevtn_dn": 894.29998779296875, "invlev_up": 937.5, "invlev_dn": 891.79998779296875, "manhole_up": "manhole_224_generated", "manhole_dn": "manhole_225_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387284.798919493798167, 5856790.190159549936652 ], [ 1387273.050185391213745, 5856831.931571422144771 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1108", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 894.29998779296875, "elevtn_dn": 891.5, "invlev_up": 891.79998779296875, "invlev_dn": 889.0, "manhole_up": "manhole_225_generated", "manhole_dn": "manhole_226_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387273.050185391213745, 5856831.931571422144771 ], [ 1387226.106990416301414, 5856849.145192969590425 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1109", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 891.5, "elevtn_dn": 891.5, "invlev_up": 889.0, "invlev_dn": 889.0, "manhole_up": "manhole_226_generated", "manhole_dn": "manhole_227_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387226.106990416301414, 5856849.145192969590425 ], [ 1387179.163795441389084, 5856866.358814516104758 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1110", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 891.5, "elevtn_dn": 881.0, "invlev_up": 889.0, "invlev_dn": 878.5, "manhole_up": "manhole_227_generated", "manhole_dn": "manhole_228_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387179.163795441389084, 5856866.358814516104758 ], [ 1387132.220600466709584, 5856883.572436063550413 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1111", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_228_generated", "manhole_dn": "manhole_229_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387132.220600466709584, 5856883.572436063550413 ], [ 1387091.513159692520276, 5856911.129930667579174 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1112", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_229_generated", "manhole_dn": "manhole_230_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387091.513159692520276, 5856911.129930667579174 ], [ 1387071.007118243258446, 5856956.15559543017298 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1113", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_230_generated", "manhole_dn": "manhole_231_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387071.007118243258446, 5856956.15559543017298 ], [ 1387043.749112035380676, 5856996.689189162105322 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1114", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 856.5, "invlev_up": 878.5, "invlev_dn": 854.0, "manhole_up": "manhole_231_generated", "manhole_dn": "manhole_232_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387043.749112035380676, 5856996.689189162105322 ], [ 1387004.639443967491388, 5857027.840532388538122 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1115", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_232_generated", "manhole_dn": "manhole_233_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387004.639443967491388, 5857027.840532388538122 ], [ 1386965.529775899834931, 5857058.991875615902245 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1116", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_233_generated", "manhole_dn": "manhole_234_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386965.529775899834931, 5857058.991875615902245 ], [ 1386926.702535050921142, 5857090.440239730291069 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1117", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_234_generated", "manhole_dn": "manhole_235_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386926.702535050921142, 5857090.440239730291069 ], [ 1386899.700979894958436, 5857131.871505072340369 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1118", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_235_generated", "manhole_dn": "manhole_236_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386899.700979894958436, 5857131.871505072340369 ], [ 1386903.6263940166682, 5857181.005935152061284 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1119", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 867.29998779296875, "invlev_up": 854.0, "invlev_dn": 864.79998779296875, "manhole_up": "manhole_236_generated", "manhole_dn": "manhole_237_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386903.6263940166682, 5857181.005935152061284 ], [ 1386920.841401966754347, 5857227.85734468139708 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1120", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 867.29998779296875, "elevtn_dn": 867.29998779296875, "invlev_up": 864.79998779296875, "invlev_dn": 864.79998779296875, "manhole_up": "manhole_237_generated", "manhole_dn": "manhole_238_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386920.841401966754347, 5857227.85734468139708 ], [ 1386940.647245415020734, 5857273.767048302106559 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1121", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 867.29998779296875, "elevtn_dn": 879.0, "invlev_up": 864.79998779296875, "invlev_dn": 876.5, "manhole_up": "manhole_238_generated", "manhole_dn": "manhole_239_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386940.647245415020734, 5857273.767048302106559 ], [ 1386960.453088863519952, 5857319.676751921884716 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1122", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 879.0, "elevtn_dn": 884.5, "invlev_up": 876.5, "invlev_dn": 882.0, "manhole_up": "manhole_239_generated", "manhole_dn": "manhole_240_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386960.453088863519952, 5857319.676751921884716 ], [ 1386980.258932311786339, 5857365.586455542594194 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1123", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 884.5, "invlev_up": 882.0, "invlev_dn": 882.0, "manhole_up": "manhole_240_generated", "manhole_dn": "manhole_241_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386980.258932311786339, 5857365.586455542594194 ], [ 1387000.064775760285556, 5857411.496159162372351 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1124", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 884.5, "invlev_up": 882.0, "invlev_dn": 882.0, "manhole_up": "manhole_241_generated", "manhole_dn": "manhole_242_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387000.064775760285556, 5857411.496159162372351 ], [ 1387007.528902114601806, 5857459.537025099620223 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1125", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 893.20001220703125, "invlev_up": 882.0, "invlev_dn": 890.70001220703125, "manhole_up": "manhole_242_generated", "manhole_dn": "manhole_243_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387007.528902114601806, 5857459.537025099620223 ], [ 1386963.21676475298591, 5857476.629049208015203 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1126", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 893.20001220703125, "elevtn_dn": 893.70001220703125, "invlev_up": 890.70001220703125, "invlev_dn": 891.20001220703125, "manhole_up": "manhole_243_generated", "manhole_dn": "manhole_244_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386963.21676475298591, 5857476.629049208015203 ], [ 1386913.783934087026864, 5857484.135433598421514 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1127", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 893.70001220703125, "elevtn_dn": 893.70001220703125, "invlev_up": 891.20001220703125, "invlev_dn": 891.20001220703125, "manhole_up": "manhole_244_generated", "manhole_dn": "manhole_245_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386913.783934087026864, 5857484.135433598421514 ], [ 1386870.539328352315351, 5857507.055611960589886 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1128", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 893.70001220703125, "elevtn_dn": 889.70001220703125, "invlev_up": 891.20001220703125, "invlev_dn": 887.20001220703125, "manhole_up": "manhole_245_generated", "manhole_dn": "manhole_246_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386870.539328352315351, 5857507.055611960589886 ], [ 1386832.820274166297168, 5857539.877026806585491 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1129", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 889.70001220703125, "elevtn_dn": 889.70001220703125, "invlev_up": 887.20001220703125, "invlev_dn": 887.20001220703125, "manhole_up": "manhole_246_generated", "manhole_dn": "manhole_247_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386832.820274166297168, 5857539.877026806585491 ], [ 1386795.101531907683238, 5857572.698800123296678 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1130", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 889.70001220703125, "elevtn_dn": 872.4000244140625, "invlev_up": 887.20001220703125, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_247_generated", "manhole_dn": "manhole_248_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386795.101531907683238, 5857572.698800123296678 ], [ 1386758.257366374600679, 5857606.496797049418092 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1131", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 872.4000244140625, "invlev_up": 869.9000244140625, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_248_generated", "manhole_dn": "manhole_249_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386758.257366374600679, 5857606.496797049418092 ], [ 1386721.502390186069533, 5857640.394349270500243 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1132", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 872.4000244140625, "invlev_up": 869.9000244140625, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_249_generated", "manhole_dn": "manhole_250_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386721.502390186069533, 5857640.394349270500243 ], [ 1386691.639095245627686, 5857680.292891399934888 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1133", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 860.70001220703125, "invlev_up": 869.9000244140625, "invlev_dn": 858.20001220703125, "manhole_up": "manhole_250_generated", "manhole_dn": "manhole_251_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386691.639095245627686, 5857680.292891399934888 ], [ 1386663.127201205352321, 5857721.366519738920033 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1134", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 860.70001220703125, "elevtn_dn": 864.10003662109375, "invlev_up": 858.20001220703125, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_251_generated", "manhole_dn": "manhole_252_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386663.127201205352321, 5857721.366519738920033 ], [ 1386634.70784462057054, 5857762.504245642572641 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1135", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 864.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_252_generated", "manhole_dn": "manhole_253_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386634.70784462057054, 5857762.504245642572641 ], [ 1386606.28848803602159, 5857803.64197154622525 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1136", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 864.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_253_generated", "manhole_dn": "manhole_254_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386606.28848803602159, 5857803.64197154622525 ], [ 1386577.851668093586341, 5857844.766917760483921 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1137", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 836.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 833.60003662109375, "manhole_up": "manhole_254_generated", "manhole_dn": "manhole_255_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386577.851668093586341, 5857844.766917760483921 ], [ 1386559.479123871540651, 5857890.340473555959761 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1138", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 836.10003662109375, "elevtn_dn": 836.10003662109375, "invlev_up": 833.60003662109375, "invlev_dn": 833.60003662109375, "manhole_up": "manhole_255_generated", "manhole_dn": "manhole_256_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386559.479123871540651, 5857890.340473555959761 ], [ 1386576.858566463226452, 5857935.633445805869997 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1139", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 836.10003662109375, "elevtn_dn": 854.9000244140625, "invlev_up": 833.60003662109375, "invlev_dn": 852.4000244140625, "manhole_up": "manhole_256_generated", "manhole_dn": "manhole_257_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386576.858566463226452, 5857935.633445805869997 ], [ 1386619.073707325849682, 5857961.189545376226306 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1140", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 854.9000244140625, "elevtn_dn": 854.9000244140625, "invlev_up": 852.4000244140625, "invlev_dn": 852.4000244140625, "manhole_up": "manhole_257_generated", "manhole_dn": "manhole_258_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386619.073707325849682, 5857961.189545376226306 ], [ 1386664.860782509436831, 5857981.27706332411617 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1141", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 854.9000244140625, "elevtn_dn": 871.60003662109375, "invlev_up": 852.4000244140625, "invlev_dn": 869.10003662109375, "manhole_up": "manhole_258_generated", "manhole_dn": "manhole_259_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386664.860782509436831, 5857981.27706332411617 ], [ 1386710.721602912992239, 5858001.195835201069713 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1142", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 871.60003662109375, "elevtn_dn": 865.10003662109375, "invlev_up": 869.10003662109375, "invlev_dn": 862.60003662109375, "manhole_up": "manhole_259_generated", "manhole_dn": "manhole_260_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386710.721602912992239, 5858001.195835201069713 ], [ 1386756.582423316547647, 5858021.114607078954577 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1143", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 865.10003662109375, "elevtn_dn": 864.70001220703125, "invlev_up": 862.60003662109375, "invlev_dn": 862.20001220703125, "manhole_up": "manhole_260_generated", "manhole_dn": "manhole_261_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386756.582423316547647, 5858021.114607078954577 ], [ 1386802.443243720103055, 5858041.033378956839442 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1144", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 864.70001220703125, "elevtn_dn": 864.70001220703125, "invlev_up": 862.20001220703125, "invlev_dn": 862.20001220703125, "manhole_up": "manhole_261_generated", "manhole_dn": "manhole_262_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386802.443243720103055, 5858041.033378956839442 ], [ 1386848.304064123658463, 5858060.952150834724307 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1145", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 864.70001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 862.20001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_262_generated", "manhole_dn": "manhole_263_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386848.304064123658463, 5858060.952150834724307 ], [ 1386892.843548113014549, 5858083.471454747952521 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1146", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_263_generated", "manhole_dn": "manhole_264_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386892.843548113014549, 5858083.471454747952521 ], [ 1386931.443847785238177, 5858115.251781782135367 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1147", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 853.60003662109375, "invlev_up": 856.70001220703125, "invlev_dn": 851.10003662109375, "manhole_up": "manhole_264_generated", "manhole_dn": "manhole_265_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386931.443847785238177, 5858115.251781782135367 ], [ 1386970.044147457228974, 5858147.032108817249537 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1148", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 853.60003662109375, "elevtn_dn": 853.60003662109375, "invlev_up": 851.10003662109375, "invlev_dn": 851.10003662109375, "manhole_up": "manhole_265_generated", "manhole_dn": "manhole_266_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386970.044147457228974, 5858147.032108817249537 ], [ 1387008.644447129452601, 5858178.812435851432383 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1149", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 853.60003662109375, "elevtn_dn": 842.4000244140625, "invlev_up": 851.10003662109375, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_266_generated", "manhole_dn": "manhole_267_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387008.644447129452601, 5858178.812435851432383 ], [ 1387047.244746801443398, 5858210.592762886546552 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1150", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 842.4000244140625, "invlev_up": 839.9000244140625, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_267_generated", "manhole_dn": "manhole_268_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387047.244746801443398, 5858210.592762886546552 ], [ 1387085.845046473667026, 5858242.373089920729399 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1151", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 842.4000244140625, "invlev_up": 839.9000244140625, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_268_generated", "manhole_dn": "manhole_269_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387085.845046473667026, 5858242.373089920729399 ], [ 1387124.445346145657822, 5858274.153416955843568 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1152", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 827.60003662109375, "invlev_up": 839.9000244140625, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_269_generated", "manhole_dn": "manhole_270_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387124.445346145657822, 5858274.153416955843568 ], [ 1387163.04564581788145, 5858305.933743990026414 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1153", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_270_generated", "manhole_dn": "manhole_271_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387163.04564581788145, 5858305.933743990026414 ], [ 1387201.829349192325026, 5858337.489215047098696 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1154", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 837.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 835.10003662109375, "manhole_up": "manhole_271_generated", "manhole_dn": "manhole_272_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387201.829349192325026, 5858337.489215047098696 ], [ 1387246.200623227981851, 5858359.687651782296598 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1155", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 837.60003662109375, "elevtn_dn": 837.60003662109375, "invlev_up": 835.10003662109375, "invlev_dn": 835.10003662109375, "manhole_up": "manhole_272_generated", "manhole_dn": "manhole_273_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387246.200623227981851, 5858359.687651782296598 ], [ 1387293.201938283629715, 5858376.741938757710159 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1156", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 837.60003662109375, "elevtn_dn": 843.79998779296875, "invlev_up": 835.10003662109375, "invlev_dn": 841.29998779296875, "manhole_up": "manhole_273_generated", "manhole_dn": "manhole_274_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387293.201938283629715, 5858376.741938757710159 ], [ 1387334.200528149493039, 5858401.732468435540795 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1157", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 843.79998779296875, "elevtn_dn": 822.60003662109375, "invlev_up": 841.29998779296875, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_274_generated", "manhole_dn": "manhole_275_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387334.200528149493039, 5858401.732468435540795 ], [ 1387307.843875054037198, 5858437.110805934295058 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1158", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 822.60003662109375, "invlev_up": 820.10003662109375, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_275_generated", "manhole_dn": "manhole_276_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387307.843875054037198, 5858437.110805934295058 ], [ 1387260.279569417703897, 5858425.045736069791019 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1159", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 820.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_276_generated", "manhole_dn": "manhole_277_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387260.279569417703897, 5858425.045736069791019 ], [ 1387211.448235018178821, 5858414.300554806366563 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1160", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_277_generated", "manhole_dn": "manhole_278_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387211.448235018178821, 5858414.300554806366563 ], [ 1387162.612191663123667, 5858403.576134512200952 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1161", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 822.29998779296875, "invlev_up": 825.10003662109375, "invlev_dn": 819.79998779296875, "manhole_up": "manhole_278_generated", "manhole_dn": "manhole_279_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387162.612191663123667, 5858403.576134512200952 ], [ 1387113.700150535441935, 5858393.210482948459685 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1162", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 822.29998779296875, "elevtn_dn": 822.29998779296875, "invlev_up": 819.79998779296875, "invlev_dn": 819.79998779296875, "manhole_up": "manhole_279_generated", "manhole_dn": "manhole_280_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387113.700150535441935, 5858393.210482948459685 ], [ 1387064.993171223672107, 5858381.975642333738506 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1163", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 822.29998779296875, "elevtn_dn": 827.79998779296875, "invlev_up": 819.79998779296875, "invlev_dn": 825.29998779296875, "manhole_up": "manhole_280_generated", "manhole_dn": "manhole_281_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387064.993171223672107, 5858381.975642333738506 ], [ 1387015.796386598376557, 5858376.342007979750633 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1164", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.79998779296875, "elevtn_dn": 827.79998779296875, "invlev_up": 825.29998779296875, "invlev_dn": 825.29998779296875, "manhole_up": "manhole_281_generated", "manhole_dn": "manhole_282_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387015.796386598376557, 5858376.342007979750633 ], [ 1386966.208506174152717, 5858382.746259398758411 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1165", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.79998779296875, "elevtn_dn": 833.9000244140625, "invlev_up": 825.29998779296875, "invlev_dn": 831.4000244140625, "manhole_up": "manhole_282_generated", "manhole_dn": "manhole_283_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386966.208506174152717, 5858382.746259398758411 ], [ 1386916.676812386140227, 5858389.559525708667934 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1166", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 833.9000244140625, "elevtn_dn": 833.9000244140625, "invlev_up": 831.4000244140625, "invlev_dn": 831.4000244140625, "manhole_up": "manhole_283_generated", "manhole_dn": "manhole_284_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386916.676812386140227, 5858389.559525708667934 ], [ 1386867.198860567295924, 5858396.764010772109032 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1167", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 833.9000244140625, "elevtn_dn": 833.20001220703125, "invlev_up": 831.4000244140625, "invlev_dn": 830.70001220703125, "manhole_up": "manhole_284_generated", "manhole_dn": "manhole_285_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386867.198860567295924, 5858396.764010772109032 ], [ 1386820.816385147860274, 5858411.854353901930153 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1168", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 833.20001220703125, "elevtn_dn": 809.60003662109375, "invlev_up": 830.70001220703125, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_285_generated", "manhole_dn": "manhole_286_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386820.816385147860274, 5858411.854353901930153 ], [ 1386841.361234750133008, 5858445.514383808709681 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1169", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 809.79998779296875, "invlev_up": 807.10003662109375, "invlev_dn": 807.29998779296875, "manhole_up": "manhole_286_generated", "manhole_dn": "manhole_287_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386841.361234750133008, 5858445.514383808709681 ], [ 1386890.796275103231892, 5858452.915634987875819 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1170", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.79998779296875, "elevtn_dn": 809.79998779296875, "invlev_up": 807.29998779296875, "invlev_dn": 807.29998779296875, "manhole_up": "manhole_287_generated", "manhole_dn": "manhole_288_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386890.796275103231892, 5858452.915634987875819 ], [ 1386940.277140651131049, 5858460.100081093609333 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1171", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.79998779296875, "elevtn_dn": 805.4000244140625, "invlev_up": 807.29998779296875, "invlev_dn": 802.9000244140625, "manhole_up": "manhole_288_generated", "manhole_dn": "manhole_289_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386940.277140651131049, 5858460.100081093609333 ], [ 1386989.847997799050063, 5858466.483407464809716 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1172", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.4000244140625, "elevtn_dn": 805.4000244140625, "invlev_up": 802.9000244140625, "invlev_dn": 802.9000244140625, "manhole_up": "manhole_289_generated", "manhole_dn": "manhole_290_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386989.847997799050063, 5858466.483407464809716 ], [ 1387039.689648573985323, 5858470.45608530472964 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1173", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.4000244140625, "elevtn_dn": 804.60003662109375, "invlev_up": 802.9000244140625, "invlev_dn": 802.10003662109375, "manhole_up": "manhole_290_generated", "manhole_dn": "manhole_291_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387039.689648573985323, 5858470.45608530472964 ], [ 1387088.843806148739532, 5858479.424946941435337 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1174", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.60003662109375, "elevtn_dn": 809.9000244140625, "invlev_up": 802.10003662109375, "invlev_dn": 807.4000244140625, "manhole_up": "manhole_291_generated", "manhole_dn": "manhole_292_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387088.843806148739532, 5858479.424946941435337 ], [ 1387137.90604472765699, 5858489.061806742101908 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1175", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.9000244140625, "elevtn_dn": 809.9000244140625, "invlev_up": 807.4000244140625, "invlev_dn": 807.4000244140625, "manhole_up": "manhole_292_generated", "manhole_dn": "manhole_293_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387137.90604472765699, 5858489.061806742101908 ], [ 1387186.336529975291342, 5858500.87968063633889 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1176", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.9000244140625, "elevtn_dn": 822.60003662109375, "invlev_up": 807.4000244140625, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_293_generated", "manhole_dn": "manhole_294_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387186.336529975291342, 5858500.87968063633889 ], [ 1387231.661050535272807, 5858521.423059928230941 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1177", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 787.70001220703125, "invlev_up": 820.10003662109375, "invlev_dn": 785.20001220703125, "manhole_up": "manhole_294_generated", "manhole_dn": "manhole_295_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387231.661050535272807, 5858521.423059928230941 ], [ 1387268.120024613803253, 5858555.03504909388721 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1178", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 787.70001220703125, "elevtn_dn": 787.70001220703125, "invlev_up": 785.20001220703125, "invlev_dn": 785.20001220703125, "manhole_up": "manhole_295_generated", "manhole_dn": "manhole_296_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387268.120024613803253, 5858555.03504909388721 ], [ 1387300.917169471969828, 5858592.775208213366568 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1179", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 787.70001220703125, "elevtn_dn": 797.10003662109375, "invlev_up": 785.20001220703125, "invlev_dn": 794.60003662109375, "manhole_up": "manhole_296_generated", "manhole_dn": "manhole_297_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387300.917169471969828, 5858592.775208213366568 ], [ 1387340.521646688459441, 5858622.315198052674532 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1180", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 797.10003662109375, "elevtn_dn": 797.10003662109375, "invlev_up": 794.60003662109375, "invlev_dn": 794.60003662109375, "manhole_up": "manhole_297_generated", "manhole_dn": "manhole_298_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387340.521646688459441, 5858622.315198052674532 ], [ 1387387.476920192595571, 5858639.495844470337033 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1181", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 797.10003662109375, "elevtn_dn": 806.10003662109375, "invlev_up": 794.60003662109375, "invlev_dn": 803.60003662109375, "manhole_up": "manhole_298_generated", "manhole_dn": "manhole_299_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387387.476920192595571, 5858639.495844470337033 ], [ 1387436.116963447071612, 5858650.82861250359565 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1182", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.10003662109375, "elevtn_dn": 806.10003662109375, "invlev_up": 803.60003662109375, "invlev_dn": 803.60003662109375, "manhole_up": "manhole_299_generated", "manhole_dn": "manhole_300_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387436.116963447071612, 5858650.82861250359565 ], [ 1387485.194103535497561, 5858660.261457678861916 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1183", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.10003662109375, "elevtn_dn": 807.70001220703125, "invlev_up": 803.60003662109375, "invlev_dn": 805.20001220703125, "manhole_up": "manhole_300_generated", "manhole_dn": "manhole_301_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387485.194103535497561, 5858660.261457678861916 ], [ 1387533.804190448950976, 5858671.493853995576501 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1184", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.70001220703125, "elevtn_dn": 772.20001220703125, "invlev_up": 805.20001220703125, "invlev_dn": 769.70001220703125, "manhole_up": "manhole_301_generated", "manhole_dn": "manhole_302_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387533.804190448950976, 5858671.493853995576501 ], [ 1387580.2968336828053, 5858689.619015210308135 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1185", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.20001220703125, "elevtn_dn": 778.79998779296875, "invlev_up": 769.70001220703125, "invlev_dn": 776.29998779296875, "manhole_up": "manhole_302_generated", "manhole_dn": "manhole_303_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387580.2968336828053, 5858689.619015210308135 ], [ 1387628.455277157016098, 5858703.062848121859133 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1186", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.79998779296875, "elevtn_dn": 778.79998779296875, "invlev_up": 776.29998779296875, "invlev_dn": 776.29998779296875, "manhole_up": "manhole_303_generated", "manhole_dn": "manhole_304_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387628.455277157016098, 5858703.062848121859133 ], [ 1387677.211432087467983, 5858713.7862489502877 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1187", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.79998779296875, "elevtn_dn": 786.70001220703125, "invlev_up": 776.29998779296875, "invlev_dn": 784.20001220703125, "manhole_up": "manhole_304_generated", "manhole_dn": "manhole_305_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387677.211432087467983, 5858713.7862489502877 ], [ 1387726.995392211945727, 5858712.747126803733408 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1188", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.70001220703125, "elevtn_dn": 786.70001220703125, "invlev_up": 784.20001220703125, "invlev_dn": 784.20001220703125, "manhole_up": "manhole_305_generated", "manhole_dn": "manhole_306_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387726.995392211945727, 5858712.747126803733408 ], [ 1387773.343349169706926, 5858725.014477553777397 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1189", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.70001220703125, "elevtn_dn": 797.70001220703125, "invlev_up": 784.20001220703125, "invlev_dn": 795.20001220703125, "manhole_up": "manhole_306_generated", "manhole_dn": "manhole_307_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387773.343349169706926, 5858725.014477553777397 ], [ 1387806.363672176143155, 5858762.310494473204017 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1190", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 797.70001220703125, "elevtn_dn": 797.70001220703125, "invlev_up": 795.20001220703125, "invlev_dn": 795.20001220703125, "manhole_up": "manhole_307_generated", "manhole_dn": "manhole_308_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387806.363672176143155, 5858762.310494473204017 ], [ 1387799.717027904232964, 5858810.149600365199149 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1191", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 797.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 795.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_308_generated", "manhole_dn": "manhole_309_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387799.717027904232964, 5858810.149600365199149 ], [ 1387771.971139753237367, 5858850.86109375115484 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1192", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_309_generated", "manhole_dn": "manhole_310_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387771.971139753237367, 5858850.86109375115484 ], [ 1387723.07675126590766, 5858854.679317841306329 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1193", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_310_generated", "manhole_dn": "manhole_311_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387723.07675126590766, 5858854.679317841306329 ], [ 1387673.274138238513842, 5858850.996178055182099 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1194", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_311_generated", "manhole_dn": "manhole_312_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387673.274138238513842, 5858850.996178055182099 ], [ 1387624.170362570788711, 5858858.384703231044114 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1195", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_312_generated", "manhole_dn": "manhole_313_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387624.170362570788711, 5858858.384703231044114 ], [ 1387575.715393897145987, 5858857.046076283790171 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1196", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_313_generated", "manhole_dn": "manhole_314_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387575.715393897145987, 5858857.046076283790171 ], [ 1387529.438332577701658, 5858838.116818149574101 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1197", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_314_generated", "manhole_dn": "manhole_315_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387529.438332577701658, 5858838.116818149574101 ], [ 1387481.179235466290265, 5858825.222027675248682 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1198", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_315_generated", "manhole_dn": "manhole_316_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387481.179235466290265, 5858825.222027675248682 ], [ 1387432.215501294471323, 5858815.797906777821481 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1199", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 772.79998779296875, "invlev_up": 774.70001220703125, "invlev_dn": 770.29998779296875, "manhole_up": "manhole_316_generated", "manhole_dn": "manhole_317_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387432.215501294471323, 5858815.797906777821481 ], [ 1387382.431881646160036, 5858811.154251328669488 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1200", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.79998779296875, "elevtn_dn": 747.10003662109375, "invlev_up": 770.29998779296875, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_317_generated", "manhole_dn": "manhole_318_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387382.431881646160036, 5858811.154251328669488 ], [ 1387336.607072548242286, 5858824.075685098767281 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1201", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 747.10003662109375, "invlev_up": 744.60003662109375, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_318_generated", "manhole_dn": "manhole_319_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387336.607072548242286, 5858824.075685098767281 ], [ 1387327.458137275883928, 5858870.88596049696207 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1202", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 747.10003662109375, "invlev_up": 744.60003662109375, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_319_generated", "manhole_dn": "manhole_320_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387327.458137275883928, 5858870.88596049696207 ], [ 1387344.619252334116027, 5858917.848375800997019 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1203", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 773.70001220703125, "invlev_up": 744.60003662109375, "invlev_dn": 771.20001220703125, "manhole_up": "manhole_320_generated", "manhole_dn": "manhole_321_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387344.619252334116027, 5858917.848375800997019 ], [ 1387358.089983508689329, 5858965.710649829357862 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1204", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 773.70001220703125, "elevtn_dn": 773.70001220703125, "invlev_up": 771.20001220703125, "invlev_dn": 771.20001220703125, "manhole_up": "manhole_321_generated", "manhole_dn": "manhole_322_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387358.089983508689329, 5858965.710649829357862 ], [ 1387329.564612702699378, 5859003.583583393134177 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1205", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 773.70001220703125, "elevtn_dn": 774.29998779296875, "invlev_up": 771.20001220703125, "invlev_dn": 771.79998779296875, "manhole_up": "manhole_322_generated", "manhole_dn": "manhole_323_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387329.564612702699378, 5859003.583583393134177 ], [ 1387285.783744251355529, 5858993.703191691078246 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1206", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 774.29998779296875, "elevtn_dn": 774.29998779296875, "invlev_up": 771.79998779296875, "invlev_dn": 771.79998779296875, "manhole_up": "manhole_323_generated", "manhole_dn": "manhole_324_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387285.783744251355529, 5858993.703191691078246 ], [ 1387248.355973182013258, 5858961.31797497626394 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1207", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 774.29998779296875, "elevtn_dn": 769.4000244140625, "invlev_up": 771.79998779296875, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_324_generated", "manhole_dn": "manhole_325_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387248.355973182013258, 5858961.31797497626394 ], [ 1387199.500433639157563, 5858963.645901591517031 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1208", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 769.4000244140625, "invlev_up": 766.9000244140625, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_325_generated", "manhole_dn": "manhole_326_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387199.500433639157563, 5858963.645901591517031 ], [ 1387151.482699199579656, 5858977.583961015567183 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1209", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 762.60003662109375, "invlev_up": 766.9000244140625, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_326_generated", "manhole_dn": "manhole_327_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387151.482699199579656, 5858977.583961015567183 ], [ 1387103.632611613254994, 5858992.082134889438748 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1210", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 762.60003662109375, "invlev_up": 760.10003662109375, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_327_generated", "manhole_dn": "manhole_328_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387103.632611613254994, 5858992.082134889438748 ], [ 1387055.853339510038495, 5859006.816905959509313 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1211", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 755.79998779296875, "invlev_up": 760.10003662109375, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_328_generated", "manhole_dn": "manhole_329_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387055.853339510038495, 5859006.816905959509313 ], [ 1387008.074067406589165, 5859021.551677029579878 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1212", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_329_generated", "manhole_dn": "manhole_330_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387008.074067406589165, 5859021.551677029579878 ], [ 1386960.294795303372666, 5859036.286448099650443 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1213", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 749.5, "invlev_up": 753.29998779296875, "invlev_dn": 747.0, "manhole_up": "manhole_330_generated", "manhole_dn": "manhole_331_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386960.294795303372666, 5859036.286448099650443 ], [ 1386912.515523200156167, 5859051.021219169721007 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1214", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 749.5, "elevtn_dn": 749.5, "invlev_up": 747.0, "invlev_dn": 747.0, "manhole_up": "manhole_331_generated", "manhole_dn": "manhole_332_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386912.515523200156167, 5859051.021219169721007 ], [ 1386864.736251096706837, 5859065.755990239791572 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1215", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 749.5, "elevtn_dn": 727.10003662109375, "invlev_up": 747.0, "invlev_dn": 724.60003662109375, "manhole_up": "manhole_332_generated", "manhole_dn": "manhole_333_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386864.736251096706837, 5859065.755990239791572 ], [ 1386816.956978993490338, 5859080.490761309862137 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1216", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 727.10003662109375, "elevtn_dn": 752.29998779296875, "invlev_up": 724.60003662109375, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_333_generated", "manhole_dn": "manhole_334_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386816.956978993490338, 5859080.490761309862137 ], [ 1386769.832018451532349, 5859096.976014334708452 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1217", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 738.0, "invlev_up": 749.79998779296875, "invlev_dn": 735.5, "manhole_up": "manhole_334_generated", "manhole_dn": "manhole_335_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386769.832018451532349, 5859096.976014334708452 ], [ 1386724.102282747160643, 5859117.193917133845389 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1218", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 738.0, "invlev_up": 735.5, "invlev_dn": 735.5, "manhole_up": "manhole_335_generated", "manhole_dn": "manhole_336_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386724.102282747160643, 5859117.193917133845389 ], [ 1386678.372547042788938, 5859137.411819933913648 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1219", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 732.79998779296875, "invlev_up": 735.5, "invlev_dn": 730.29998779296875, "manhole_up": "manhole_336_generated", "manhole_dn": "manhole_337_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386678.372547042788938, 5859137.411819933913648 ], [ 1386632.642811338417232, 5859157.629722733050585 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1220", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.79998779296875, "elevtn_dn": 732.79998779296875, "invlev_up": 730.29998779296875, "invlev_dn": 730.29998779296875, "manhole_up": "manhole_337_generated", "manhole_dn": "manhole_338_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386632.642811338417232, 5859157.629722733050585 ], [ 1386586.913075634045526, 5859177.847625533118844 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1221", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.79998779296875, "elevtn_dn": 732.60003662109375, "invlev_up": 730.29998779296875, "invlev_dn": 730.10003662109375, "manhole_up": "manhole_338_generated", "manhole_dn": "manhole_339_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386586.913075634045526, 5859177.847625533118844 ], [ 1386541.181931287748739, 5859198.062337793409824 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1222", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.60003662109375, "elevtn_dn": 732.60003662109375, "invlev_up": 730.10003662109375, "invlev_dn": 730.10003662109375, "manhole_up": "manhole_339_generated", "manhole_dn": "manhole_340_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386541.181931287748739, 5859198.062337793409824 ], [ 1386495.431538854492828, 5859218.233453613705933 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1223", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.60003662109375, "elevtn_dn": 742.5, "invlev_up": 730.10003662109375, "invlev_dn": 740.0, "manhole_up": "manhole_340_generated", "manhole_dn": "manhole_341_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386495.431538854492828, 5859218.233453613705933 ], [ 1386449.681146421469748, 5859238.404569433070719 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1224", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 742.5, "invlev_up": 740.0, "invlev_dn": 740.0, "manhole_up": "manhole_341_generated", "manhole_dn": "manhole_342_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386449.681146421469748, 5859238.404569433070719 ], [ 1386404.749107032548636, 5859260.314221715554595 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1225", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 717.60003662109375, "invlev_up": 740.0, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_342_generated", "manhole_dn": "manhole_343_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386404.749107032548636, 5859260.314221715554595 ], [ 1386360.756595908896998, 5859284.020064728334546 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1226", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 717.60003662109375, "invlev_up": 715.10003662109375, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_343_generated", "manhole_dn": "manhole_344_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386360.756595908896998, 5859284.020064728334546 ], [ 1386317.622744857333601, 5859309.307279178872705 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1227", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 711.0, "invlev_up": 715.10003662109375, "invlev_dn": 708.5, "manhole_up": "manhole_344_generated", "manhole_dn": "manhole_345_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386317.622744857333601, 5859309.307279178872705 ], [ 1386274.488893805770203, 5859334.594493629410863 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1228", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 711.0, "elevtn_dn": 717.60003662109375, "invlev_up": 708.5, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_345_generated", "manhole_dn": "manhole_346_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386274.488893805770203, 5859334.594493629410863 ], [ 1386231.354723542230204, 5859359.881163572892547 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1229", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 739.0, "invlev_up": 715.10003662109375, "invlev_dn": 736.5, "manhole_up": "manhole_346_generated", "manhole_dn": "manhole_347_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386231.354723542230204, 5859359.881163572892547 ], [ 1386188.788941488368437, 5859385.978958465158939 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1230", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 739.0, "invlev_up": 736.5, "invlev_dn": 736.5, "manhole_up": "manhole_347_generated", "manhole_dn": "manhole_348_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386188.788941488368437, 5859385.978958465158939 ], [ 1386153.170269979629666, 5859420.751348914578557 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1231", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 739.0, "invlev_up": 736.5, "invlev_dn": 736.5, "manhole_up": "manhole_348_generated", "manhole_dn": "manhole_349_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386153.170269979629666, 5859420.751348914578557 ], [ 1386127.241226618411019, 5859463.08446778729558 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1232", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 770.60003662109375, "invlev_up": 736.5, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_349_generated", "manhole_dn": "manhole_350_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386127.241226618411019, 5859463.08446778729558 ], [ 1386108.996456971857697, 5859509.052053713239729 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1233", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_350_generated", "manhole_dn": "manhole_351_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386108.996456971857697, 5859509.052053713239729 ], [ 1386105.954033384332433, 5859558.959127158857882 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1234", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_351_generated", "manhole_dn": "manhole_352_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386105.954033384332433, 5859558.959127158857882 ], [ 1386101.917093347059563, 5859608.782215913757682 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1235", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 779.79998779296875, "invlev_up": 768.10003662109375, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_352_generated", "manhole_dn": "manhole_353_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386101.917093347059563, 5859608.782215913757682 ], [ 1386088.458339030388743, 5859656.652665913105011 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1236", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 779.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_353_generated", "manhole_dn": "manhole_354_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386088.458339030388743, 5859656.652665913105011 ], [ 1386075.652030121767893, 5859704.419184413738549 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1237", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 779.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_354_generated", "manhole_dn": "manhole_355_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386075.652030121767893, 5859704.419184413738549 ], [ 1386076.574770522769541, 5859754.410392354242504 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1238", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_355_generated", "manhole_dn": "manhole_356_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386076.574770522769541, 5859754.410392354242504 ], [ 1386077.497510923538357, 5859804.401600294746459 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_9_E1239", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_356_generated", "manhole_dn": "manhole_357_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386077.497510923538357, 5859804.401600294746459 ], [ 1386078.420251324307173, 5859854.392808235250413 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E195", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 814.29998779296875, "elevtn_dn": 802.9000244140625, "invlev_up": 811.79998779296875, "invlev_dn": 800.4000244140625, "manhole_up": "manhole_358_generated", "manhole_dn": "manhole_359_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384050.267680946970358, 5856698.702001548372209 ], [ 1384085.778961833100766, 5856733.441067186184227 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E196", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 802.9000244140625, "elevtn_dn": 802.9000244140625, "invlev_up": 800.4000244140625, "invlev_dn": 800.4000244140625, "manhole_up": "manhole_359_generated", "manhole_dn": "manhole_360_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384085.778961833100766, 5856733.441067186184227 ], [ 1384122.993944165529683, 5856766.592179889790714 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E197", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 802.9000244140625, "elevtn_dn": 816.29998779296875, "invlev_up": 800.4000244140625, "invlev_dn": 813.79998779296875, "manhole_up": "manhole_360_generated", "manhole_dn": "manhole_361_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384122.993944165529683, 5856766.592179889790714 ], [ 1384160.350959801580757, 5856799.578122235834599 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E198", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.29998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 813.79998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_361_generated", "manhole_dn": "manhole_362_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384160.350959801580757, 5856799.578122235834599 ], [ 1384198.384374253917485, 5856831.724873264320195 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E199", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 798.29998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_362_generated", "manhole_dn": "manhole_363_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384198.384374253917485, 5856831.724873264320195 ], [ 1384230.112839305773377, 5856870.159957353956997 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E200", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 793.9000244140625, "invlev_up": 798.29998779296875, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_363_generated", "manhole_dn": "manhole_364_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384230.112839305773377, 5856870.159957353956997 ], [ 1384259.121702386764809, 5856910.628996902145445 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E201", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 807.60003662109375, "invlev_up": 791.4000244140625, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_364_generated", "manhole_dn": "manhole_365_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384259.121702386764809, 5856910.628996902145445 ], [ 1384287.023718592710793, 5856951.925833041779697 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E202", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_365_generated", "manhole_dn": "manhole_366_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384287.023718592710793, 5856951.925833041779697 ], [ 1384314.929269487503916, 5856993.22028074786067 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E203", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_366_generated", "manhole_dn": "manhole_367_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384314.929269487503916, 5856993.22028074786067 ], [ 1384344.819752591196448, 5857033.056208833120763 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E204", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_367_generated", "manhole_dn": "manhole_368_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384344.819752591196448, 5857033.056208833120763 ], [ 1384375.891110281459987, 5857072.024425559677184 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E205", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_368_generated", "manhole_dn": "manhole_369_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384375.891110281459987, 5857072.024425559677184 ], [ 1384412.732155854580924, 5857105.507668288424611 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E206", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_369_generated", "manhole_dn": "manhole_370_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384412.732155854580924, 5857105.507668288424611 ], [ 1384450.07948348694481, 5857138.509612204506993 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E207", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_370_generated", "manhole_dn": "manhole_371_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384450.07948348694481, 5857138.509612204506993 ], [ 1384487.42686335532926, 5857171.511497005820274 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E208", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 805.0, "invlev_up": 793.4000244140625, "invlev_dn": 802.5, "manhole_up": "manhole_371_generated", "manhole_dn": "manhole_372_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384487.42686335532926, 5857171.511497005820274 ], [ 1384525.207759798038751, 5857204.014277670532465 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E209", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 796.29998779296875, "invlev_up": 802.5, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_372_generated", "manhole_dn": "manhole_373_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384525.207759798038751, 5857204.014277670532465 ], [ 1384563.111988977529109, 5857236.375065575353801 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E210", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 796.29998779296875, "invlev_up": 793.79998779296875, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_373_generated", "manhole_dn": "manhole_374_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384563.111988977529109, 5857236.375065575353801 ], [ 1384601.016218156786636, 5857268.735853480175138 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E211", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 786.10003662109375, "invlev_up": 793.79998779296875, "invlev_dn": 783.60003662109375, "manhole_up": "manhole_374_generated", "manhole_dn": "manhole_375_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384601.016218156786636, 5857268.735853480175138 ], [ 1384638.920447336044163, 5857301.096641384996474 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E212", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.10003662109375, "elevtn_dn": 794.29998779296875, "invlev_up": 783.60003662109375, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_375_generated", "manhole_dn": "manhole_376_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384638.920447336044163, 5857301.096641384996474 ], [ 1384669.604954990325496, 5857340.313404724933207 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E213", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 794.29998779296875, "invlev_up": 791.79998779296875, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_376_generated", "manhole_dn": "manhole_377_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384669.604954990325496, 5857340.313404724933207 ], [ 1384699.518247769214213, 5857380.104403200559318 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E214", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 794.29998779296875, "invlev_up": 791.79998779296875, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_377_generated", "manhole_dn": "manhole_378_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384699.518247769214213, 5857380.104403200559318 ], [ 1384719.806332413339987, 5857425.627417215146124 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E215", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 782.0, "invlev_up": 791.79998779296875, "invlev_dn": 779.5, "manhole_up": "manhole_378_generated", "manhole_dn": "manhole_379_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384719.806332413339987, 5857425.627417215146124 ], [ 1384740.094417057465762, 5857471.150431229732931 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E216", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 782.0, "elevtn_dn": 789.70001220703125, "invlev_up": 779.5, "invlev_dn": 787.20001220703125, "manhole_up": "manhole_379_generated", "manhole_dn": "manhole_380_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384740.094417057465762, 5857471.150431229732931 ], [ 1384760.382501701591536, 5857516.673445244319737 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E217", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 789.70001220703125, "elevtn_dn": 789.70001220703125, "invlev_up": 787.20001220703125, "invlev_dn": 787.20001220703125, "manhole_up": "manhole_380_generated", "manhole_dn": "manhole_381_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384760.382501701591536, 5857516.673445244319737 ], [ 1384780.670586345717311, 5857562.196459258906543 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E218", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 789.70001220703125, "elevtn_dn": 796.5, "invlev_up": 787.20001220703125, "invlev_dn": 794.0, "manhole_up": "manhole_381_generated", "manhole_dn": "manhole_382_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384780.670586345717311, 5857562.196459258906543 ], [ 1384802.672203443944454, 5857606.838341221213341 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E219", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 796.5, "elevtn_dn": 771.9000244140625, "invlev_up": 794.0, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_382_generated", "manhole_dn": "manhole_383_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384802.672203443944454, 5857606.838341221213341 ], [ 1384827.896526007680222, 5857649.823044718243182 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E220", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_383_generated", "manhole_dn": "manhole_384_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384827.896526007680222, 5857649.823044718243182 ], [ 1384854.757882944308221, 5857691.606820800341666 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E221", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_384_generated", "manhole_dn": "manhole_385_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384854.757882944308221, 5857691.606820800341666 ], [ 1384888.185768931638449, 5857728.573395187035203 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E222", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_385_generated", "manhole_dn": "manhole_386_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384888.185768931638449, 5857728.573395187035203 ], [ 1384921.613654918735847, 5857765.539969574660063 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E223", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 755.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_386_generated", "manhole_dn": "manhole_387_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384921.613654918735847, 5857765.539969574660063 ], [ 1384956.145453942706808, 5857801.445756647735834 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E224", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 755.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_387_generated", "manhole_dn": "manhole_388_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384956.145453942706808, 5857801.445756647735834 ], [ 1384991.751306539867073, 5857836.319449373520911 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E225", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 746.0, "invlev_up": 755.4000244140625, "invlev_dn": 743.5, "manhole_up": "manhole_388_generated", "manhole_dn": "manhole_389_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384991.751306539867073, 5857836.319449373520911 ], [ 1385027.357159137027338, 5857871.193142099305987 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E226", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 746.0, "elevtn_dn": 755.79998779296875, "invlev_up": 743.5, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_389_generated", "manhole_dn": "manhole_390_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385027.357159137027338, 5857871.193142099305987 ], [ 1385062.963011734187603, 5857906.066834825091064 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E227", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 728.60003662109375, "invlev_up": 753.29998779296875, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_390_generated", "manhole_dn": "manhole_391_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385062.963011734187603, 5857906.066834825091064 ], [ 1385098.568864331347868, 5857940.940527551807463 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E228", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 728.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_391_generated", "manhole_dn": "manhole_392_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385098.568864331347868, 5857940.940527551807463 ], [ 1385135.753846400883049, 5857974.029479116201401 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E229", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 728.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_392_generated", "manhole_dn": "manhole_393_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385135.753846400883049, 5857974.029479116201401 ], [ 1385175.738456205930561, 5858003.622975903563201 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E230", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 735.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 733.10003662109375, "manhole_up": "manhole_393_generated", "manhole_dn": "manhole_394_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385175.738456205930561, 5858003.622975903563201 ], [ 1385218.653756857383996, 5858028.965196672827005 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E231", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 735.60003662109375, "elevtn_dn": 735.60003662109375, "invlev_up": 733.10003662109375, "invlev_dn": 733.10003662109375, "manhole_up": "manhole_394_generated", "manhole_dn": "manhole_395_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385218.653756857383996, 5858028.965196672827005 ], [ 1385262.454936756985262, 5858052.706982978619635 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E232", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 735.60003662109375, "elevtn_dn": 742.0, "invlev_up": 733.10003662109375, "invlev_dn": 739.5, "manhole_up": "manhole_395_generated", "manhole_dn": "manhole_396_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385262.454936756985262, 5858052.706982978619635 ], [ 1385306.715555034345016, 5858075.618745312094688 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E233", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 742.0, "elevtn_dn": 742.0, "invlev_up": 739.5, "invlev_dn": 739.5, "manhole_up": "manhole_396_generated", "manhole_dn": "manhole_397_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385306.715555034345016, 5858075.618745312094688 ], [ 1385350.97617331170477, 5858098.530507644638419 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E234", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 742.0, "elevtn_dn": 736.0, "invlev_up": 739.5, "invlev_dn": 733.5, "manhole_up": "manhole_397_generated", "manhole_dn": "manhole_398_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385350.97617331170477, 5858098.530507644638419 ], [ 1385395.236791589297354, 5858121.442269978113472 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E235", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 736.0, "elevtn_dn": 736.0, "invlev_up": 733.5, "invlev_dn": 733.5, "manhole_up": "manhole_398_generated", "manhole_dn": "manhole_399_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385395.236791589297354, 5858121.442269978113472 ], [ 1385439.497409866657108, 5858144.354032310657203 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E236", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 736.0, "elevtn_dn": 737.9000244140625, "invlev_up": 733.5, "invlev_dn": 735.4000244140625, "manhole_up": "manhole_399_generated", "manhole_dn": "manhole_400_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385439.497409866657108, 5858144.354032310657203 ], [ 1385483.758028144016862, 5858167.265794644132257 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E237", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.9000244140625, "elevtn_dn": 737.9000244140625, "invlev_up": 735.4000244140625, "invlev_dn": 735.4000244140625, "manhole_up": "manhole_400_generated", "manhole_dn": "manhole_401_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385483.758028144016862, 5858167.265794644132257 ], [ 1385528.018646421376616, 5858190.17755697760731 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E238", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.9000244140625, "elevtn_dn": 727.29998779296875, "invlev_up": 735.4000244140625, "invlev_dn": 724.79998779296875, "manhole_up": "manhole_401_generated", "manhole_dn": "manhole_402_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385528.018646421376616, 5858190.17755697760731 ], [ 1385571.606102279853076, 5858214.277655217796564 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E239", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 727.29998779296875, "elevtn_dn": 727.29998779296875, "invlev_up": 724.79998779296875, "invlev_dn": 724.79998779296875, "manhole_up": "manhole_402_generated", "manhole_dn": "manhole_403_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385571.606102279853076, 5858214.277655217796564 ], [ 1385614.013400863157585, 5858240.461089110001922 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E240", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 727.29998779296875, "elevtn_dn": 690.60003662109375, "invlev_up": 724.79998779296875, "invlev_dn": 688.10003662109375, "manhole_up": "manhole_403_generated", "manhole_dn": "manhole_404_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385614.013400863157585, 5858240.461089110001922 ], [ 1385656.420699446462095, 5858266.644523002207279 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E241", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 690.60003662109375, "elevtn_dn": 733.60003662109375, "invlev_up": 688.10003662109375, "invlev_dn": 731.10003662109375, "manhole_up": "manhole_404_generated", "manhole_dn": "manhole_405_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385656.420699446462095, 5858266.644523002207279 ], [ 1385698.773111530812457, 5858292.8961898451671 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E242", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 733.60003662109375, "elevtn_dn": 733.60003662109375, "invlev_up": 731.10003662109375, "invlev_dn": 731.10003662109375, "manhole_up": "manhole_405_generated", "manhole_dn": "manhole_406_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385698.773111530812457, 5858292.8961898451671 ], [ 1385733.435650466475636, 5858328.707634637132287 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E243", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 733.60003662109375, "elevtn_dn": 721.60003662109375, "invlev_up": 731.10003662109375, "invlev_dn": 719.10003662109375, "manhole_up": "manhole_406_generated", "manhole_dn": "manhole_407_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385733.435650466475636, 5858328.707634637132287 ], [ 1385768.098189401905984, 5858364.519079428166151 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E244", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 721.60003662109375, "elevtn_dn": 721.60003662109375, "invlev_up": 719.10003662109375, "invlev_dn": 719.10003662109375, "manhole_up": "manhole_407_generated", "manhole_dn": "manhole_408_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385768.098189401905984, 5858364.519079428166151 ], [ 1385795.882535298354924, 5858405.467093757353723 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E245", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 721.60003662109375, "elevtn_dn": 739.0, "invlev_up": 719.10003662109375, "invlev_dn": 736.5, "manhole_up": "manhole_408_generated", "manhole_dn": "manhole_409_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385795.882535298354924, 5858405.467093757353723 ], [ 1385820.377634756267071, 5858448.871486231684685 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E246", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 727.79998779296875, "invlev_up": 736.5, "invlev_dn": 725.29998779296875, "manhole_up": "manhole_409_generated", "manhole_dn": "manhole_410_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385820.377634756267071, 5858448.871486231684685 ], [ 1385841.084314390551299, 5858493.920932004228234 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E247", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 727.79998779296875, "elevtn_dn": 727.79998779296875, "invlev_up": 725.29998779296875, "invlev_dn": 725.29998779296875, "manhole_up": "manhole_410_generated", "manhole_dn": "manhole_411_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385841.084314390551299, 5858493.920932004228234 ], [ 1385856.076261736918241, 5858541.451897682622075 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E248", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 727.79998779296875, "elevtn_dn": 734.9000244140625, "invlev_up": 725.29998779296875, "invlev_dn": 732.4000244140625, "manhole_up": "manhole_411_generated", "manhole_dn": "manhole_412_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385856.076261736918241, 5858541.451897682622075 ], [ 1385865.668899663724005, 5858590.250006795860827 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E249", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 734.9000244140625, "elevtn_dn": 734.9000244140625, "invlev_up": 732.4000244140625, "invlev_dn": 732.4000244140625, "manhole_up": "manhole_412_generated", "manhole_dn": "manhole_413_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385865.668899663724005, 5858590.250006795860827 ], [ 1385873.387286560609937, 5858639.487976770848036 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E250", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 734.9000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 732.4000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_413_generated", "manhole_dn": "manhole_414_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385873.387286560609937, 5858639.487976770848036 ], [ 1385875.017949819331989, 5858689.287253175862134 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E251", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 748.9000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_414_generated", "manhole_dn": "manhole_415_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385875.017949819331989, 5858689.287253175862134 ], [ 1385876.432928551919758, 5858739.106416343711317 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E252", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 748.9000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_415_generated", "manhole_dn": "manhole_416_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385876.432928551919758, 5858739.106416343711317 ], [ 1385878.329821793129668, 5858788.908141564577818 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E253", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 748.9000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_416_generated", "manhole_dn": "manhole_417_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385878.329821793129668, 5858788.908141564577818 ], [ 1385880.51921496167779, 5858838.69928275514394 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E254", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_417_generated", "manhole_dn": "manhole_418_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385880.51921496167779, 5858838.69928275514394 ], [ 1385882.620351102668792, 5858888.493530485779047 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E255", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_418_generated", "manhole_dn": "manhole_419_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385882.620351102668792, 5858888.493530485779047 ], [ 1385883.937443709466606, 5858938.315377607010305 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E256", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 766.10003662109375, "invlev_up": 757.20001220703125, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_419_generated", "manhole_dn": "manhole_420_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385883.937443709466606, 5858938.315377607010305 ], [ 1385885.254538560518995, 5858988.137224668636918 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E257", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 766.10003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_420_generated", "manhole_dn": "manhole_421_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385885.254538560518995, 5858988.137224668636918 ], [ 1385890.650534195825458, 5859037.630400610156357 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E258", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 766.10003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_421_generated", "manhole_dn": "manhole_422_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385890.650534195825458, 5859037.630400610156357 ], [ 1385901.777442803606391, 5859086.09239396546036 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E259", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 768.60003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 766.10003662109375, "manhole_up": "manhole_422_generated", "manhole_dn": "manhole_423_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385901.777442803606391, 5859086.09239396546036 ], [ 1385915.397954803425819, 5859134.03436760418117 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E260", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.60003662109375, "elevtn_dn": 762.79998779296875, "invlev_up": 766.10003662109375, "invlev_dn": 760.29998779296875, "manhole_up": "manhole_423_generated", "manhole_dn": "manhole_424_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385915.397954803425819, 5859134.03436760418117 ], [ 1385928.42605347908102, 5859182.139209139160812 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E261", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.79998779296875, "elevtn_dn": 762.5, "invlev_up": 760.29998779296875, "invlev_dn": 760.0, "manhole_up": "manhole_424_generated", "manhole_dn": "manhole_425_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385928.42605347908102, 5859182.139209139160812 ], [ 1385941.228082312969491, 5859230.306202415376902 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E262", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 762.5, "invlev_up": 760.0, "invlev_dn": 760.0, "manhole_up": "manhole_425_generated", "manhole_dn": "manhole_426_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385941.228082312969491, 5859230.306202415376902 ], [ 1385945.092689140234143, 5859279.734331246465445 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E263", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 762.5, "invlev_up": 760.0, "invlev_dn": 760.0, "manhole_up": "manhole_426_generated", "manhole_dn": "manhole_427_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385945.092689140234143, 5859279.734331246465445 ], [ 1385937.902412303024903, 5859328.779896341264248 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E264", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 778.0, "invlev_up": 760.0, "invlev_dn": 775.5, "manhole_up": "manhole_427_generated", "manhole_dn": "manhole_428_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.902412303024903, 5859328.779896341264248 ], [ 1385932.795075723901391, 5859378.173214216716588 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E265", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 778.0, "invlev_up": 775.5, "invlev_dn": 775.5, "manhole_up": "manhole_428_generated", "manhole_dn": "manhole_429_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385932.795075723901391, 5859378.173214216716588 ], [ 1385937.702695531537756, 5859427.770254967734218 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E266", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 778.0, "invlev_up": 775.5, "invlev_dn": 775.5, "manhole_up": "manhole_429_generated", "manhole_dn": "manhole_430_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.702695531537756, 5859427.770254967734218 ], [ 1385939.035937832202762, 5859477.50230407807976 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E267", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 795.9000244140625, "invlev_up": 775.5, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_430_generated", "manhole_dn": "manhole_431_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385939.035937832202762, 5859477.50230407807976 ], [ 1385937.883638251805678, 5859527.328234969638288 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E268", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_431_generated", "manhole_dn": "manhole_432_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.883638251805678, 5859527.328234969638288 ], [ 1385940.515994266141206, 5859576.989168248139322 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E269", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_432_generated", "manhole_dn": "manhole_433_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385940.515994266141206, 5859576.989168248139322 ], [ 1385950.701545101590455, 5859625.530176519416273 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E270", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 815.0, "invlev_up": 793.4000244140625, "invlev_dn": 812.5, "manhole_up": "manhole_433_generated", "manhole_dn": "manhole_434_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385950.701545101590455, 5859625.530176519416273 ], [ 1385970.467743494315073, 5859670.991298755630851 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E271", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 815.0, "elevtn_dn": 815.0, "invlev_up": 812.5, "invlev_dn": 812.5, "manhole_up": "manhole_434_generated", "manhole_dn": "manhole_435_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385970.467743494315073, 5859670.991298755630851 ], [ 1386011.983088220236823, 5859697.862916950136423 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E272", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 815.0, "elevtn_dn": 779.79998779296875, "invlev_up": 812.5, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_435_generated", "manhole_dn": "manhole_436_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386011.983088220236823, 5859697.862916950136423 ], [ 1386052.213596233632416, 5859727.119808158837259 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E273", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_436_generated", "manhole_dn": "manhole_437_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386052.213596233632416, 5859727.119808158837259 ], [ 1386046.501012831227854, 5859771.612671964801848 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E274", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_437_generated", "manhole_dn": "manhole_438_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386046.501012831227854, 5859771.612671964801848 ], [ 1386026.809695787727833, 5859816.873920152895153 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E275", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_438_generated", "manhole_dn": "manhole_439_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386026.809695787727833, 5859816.873920152895153 ], [ 1386030.149607364553958, 5859866.379009906202555 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_10_E276", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_439_generated", "manhole_dn": "manhole_440_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386030.149607364553958, 5859866.379009906202555 ], [ 1386045.250939248362556, 5859913.859036295674741 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_11_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 798.29998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_441_generated", "manhole_dn": "manhole_442_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384196.861816460033879, 5856829.88048410974443 ], [ 1384235.22519311751239, 5856854.977665597572923 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_11_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 793.9000244140625, "invlev_up": 798.29998779296875, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_442_generated", "manhole_dn": "manhole_443_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384235.22519311751239, 5856854.977665597572923 ], [ 1384263.450329831801355, 5856892.038370934315026 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_11_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 793.9000244140625, "invlev_up": 791.4000244140625, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_443_generated", "manhole_dn": "manhole_444_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384263.450329831801355, 5856892.038370934315026 ], [ 1384291.675466545857489, 5856929.099076271057129 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_11_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 807.60003662109375, "invlev_up": 791.4000244140625, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_444_generated", "manhole_dn": "manhole_445_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384291.675466545857489, 5856929.099076271057129 ], [ 1384319.900603260146454, 5856966.159781608730555 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_11_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_445_generated", "manhole_dn": "manhole_446_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384319.900603260146454, 5856966.159781608730555 ], [ 1384347.205867683747783, 5857003.894510924816132 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_11_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 799.0, "invlev_up": 805.10003662109375, "invlev_dn": 796.5, "manhole_up": "manhole_446_generated", "manhole_dn": "manhole_447_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384347.205867683747783, 5857003.894510924816132 ], [ 1384380.322691001230851, 5857036.360282040201128 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_11_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 799.0, "elevtn_dn": 807.60003662109375, "invlev_up": 796.5, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_447_generated", "manhole_dn": "manhole_448_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384380.322691001230851, 5857036.360282040201128 ], [ 1384415.156610523350537, 5857067.291694445535541 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_11_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_448_generated", "manhole_dn": "manhole_449_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384415.156610523350537, 5857067.291694445535541 ], [ 1384449.343575850594789, 5857098.828100205399096 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_11_E8", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_449_generated", "manhole_dn": "manhole_450_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384449.343575850594789, 5857098.828100205399096 ], [ 1384470.004810179118067, 5857139.926174183376133 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_11_E9", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_450_generated", "manhole_dn": "manhole_451_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384470.004810179118067, 5857139.926174183376133 ], [ 1384484.18076178082265, 5857184.301805094815791 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_12_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_452_generated", "manhole_dn": "manhole_453_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384289.06552429520525, 5856954.947841017507017 ], [ 1384305.049610810354352, 5856994.88734863139689 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_12_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_453_generated", "manhole_dn": "manhole_454_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384305.049610810354352, 5856994.88734863139689 ], [ 1384321.033697325503454, 5857034.82685624435544 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_12_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 799.0, "invlev_up": 805.10003662109375, "invlev_dn": 796.5, "manhole_up": "manhole_454_generated", "manhole_dn": "manhole_455_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384321.033697325503454, 5857034.82685624435544 ], [ 1384347.445656489115208, 5857068.672038841992617 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_12_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 799.0, "elevtn_dn": 807.60003662109375, "invlev_up": 796.5, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_455_generated", "manhole_dn": "manhole_456_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384347.445656489115208, 5857068.672038841992617 ], [ 1384374.130628447979689, 5857102.406951548531651 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_12_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_456_generated", "manhole_dn": "manhole_457_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384374.130628447979689, 5857102.406951548531651 ], [ 1384399.587644136510789, 5857137.08541233278811 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_12_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_457_generated", "manhole_dn": "manhole_458_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384399.587644136510789, 5857137.08541233278811 ], [ 1384425.04465982504189, 5857171.763873117044568 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_12_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_458_generated", "manhole_dn": "manhole_459_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384425.04465982504189, 5857171.763873117044568 ], [ 1384456.866520966170356, 5857200.577977900393307 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_15_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_15", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_15", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_459_generated", "manhole_dn": "manhole_460_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384456.866520966170356, 5857200.577977900393307 ], [ 1384480.774830641923472, 5857195.244455400854349 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_17_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_17", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_17", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 805.0, "invlev_up": 793.4000244140625, "invlev_dn": 802.5, "manhole_up": "manhole_459_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384456.866520966170356, 5857200.577977900393307 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_18_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_18", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_18", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_462_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384493.329776774393395, 5857201.952337642200291 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_19_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_19", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_19", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_462_generated", "manhole_dn": "manhole_463_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384493.329776774393395, 5857201.952337642200291 ], [ 1384511.321100181667134, 5857246.008046119473875 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_19_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_19", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_19", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_463_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384511.321100181667134, 5857246.008046119473875 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 796.29998779296875, "invlev_up": 802.5, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_464_generated", "manhole_dn": "manhole_465_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384512.484966830350459, 5857248.858029337599874 ], [ 1384550.208547196350992, 5857281.609186780638993 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 796.29998779296875, "invlev_up": 793.79998779296875, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_465_generated", "manhole_dn": "manhole_466_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384550.208547196350992, 5857281.609186780638993 ], [ 1384587.932127562351525, 5857314.360344224609435 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 809.10003662109375, "invlev_up": 793.79998779296875, "invlev_dn": 806.60003662109375, "manhole_up": "manhole_466_generated", "manhole_dn": "manhole_467_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384587.932127562351525, 5857314.360344224609435 ], [ 1384608.456866907887161, 5857358.785165345296264 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.10003662109375, "elevtn_dn": 809.10003662109375, "invlev_up": 806.60003662109375, "invlev_dn": 806.60003662109375, "manhole_up": "manhole_467_generated", "manhole_dn": "manhole_468_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384608.456866907887161, 5857358.785165345296264 ], [ 1384624.966163935838267, 5857405.935456342995167 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.10003662109375, "elevtn_dn": 794.29998779296875, "invlev_up": 806.60003662109375, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_468_generated", "manhole_dn": "manhole_469_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384624.966163935838267, 5857405.935456342995167 ], [ 1384639.938245237572119, 5857453.586039477027953 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 812.4000244140625, "invlev_up": 791.79998779296875, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_469_generated", "manhole_dn": "manhole_470_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384639.938245237572119, 5857453.586039477027953 ], [ 1384654.3423755497206, 5857501.421464210376143 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 812.4000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_470_generated", "manhole_dn": "manhole_471_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384654.3423755497206, 5857501.421464210376143 ], [ 1384665.748858094681054, 5857550.055336253717542 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 812.4000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_471_generated", "manhole_dn": "manhole_472_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384665.748858094681054, 5857550.055336253717542 ], [ 1384677.04772660904564, 5857598.717872150242329 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E8", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 818.9000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 816.4000244140625, "manhole_up": "manhole_472_generated", "manhole_dn": "manhole_473_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384677.04772660904564, 5857598.717872150242329 ], [ 1384688.346595123410225, 5857647.380408045835793 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E9", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 818.9000244140625, "elevtn_dn": 818.9000244140625, "invlev_up": 816.4000244140625, "invlev_dn": 816.4000244140625, "manhole_up": "manhole_473_generated", "manhole_dn": "manhole_474_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384688.346595123410225, 5857647.380408045835793 ], [ 1384699.64546363777481, 5857696.042943941429257 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E10", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 818.9000244140625, "elevtn_dn": 791.0, "invlev_up": 816.4000244140625, "invlev_dn": 788.5, "manhole_up": "manhole_474_generated", "manhole_dn": "manhole_475_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384699.64546363777481, 5857696.042943941429257 ], [ 1384710.944332152139395, 5857744.705479837954044 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E11", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 771.9000244140625, "invlev_up": 788.5, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_475_generated", "manhole_dn": "manhole_476_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384710.944332152139395, 5857744.705479837954044 ], [ 1384726.848783193388954, 5857791.671307560056448 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E12", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_476_generated", "manhole_dn": "manhole_477_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384726.848783193388954, 5857791.671307560056448 ], [ 1384753.929338480113074, 5857833.199649352580309 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E13", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_477_generated", "manhole_dn": "manhole_478_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384753.929338480113074, 5857833.199649352580309 ], [ 1384783.627482200739905, 5857873.006575288251042 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E14", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 791.0, "invlev_up": 769.4000244140625, "invlev_dn": 788.5, "manhole_up": "manhole_478_generated", "manhole_dn": "manhole_479_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384783.627482200739905, 5857873.006575288251042 ], [ 1384795.018452654592693, 5857920.637507135979831 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E15", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 791.0, "invlev_up": 788.5, "invlev_dn": 788.5, "manhole_up": "manhole_479_generated", "manhole_dn": "manhole_480_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384795.018452654592693, 5857920.637507135979831 ], [ 1384785.075932276435196, 5857969.445633230730891 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E16", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 820.10003662109375, "invlev_up": 788.5, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_480_generated", "manhole_dn": "manhole_481_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384785.075932276435196, 5857969.445633230730891 ], [ 1384771.479073295136914, 5858017.516749874688685 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E17", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 820.10003662109375, "invlev_up": 817.60003662109375, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_481_generated", "manhole_dn": "manhole_482_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384771.479073295136914, 5858017.516749874688685 ], [ 1384763.32518996251747, 5858066.675425447523594 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E18", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 820.10003662109375, "invlev_up": 817.60003662109375, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_482_generated", "manhole_dn": "manhole_483_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384763.32518996251747, 5858066.675425447523594 ], [ 1384757.405406558187678, 5858116.280495692044497 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E19", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 847.0, "invlev_up": 817.60003662109375, "invlev_dn": 844.5, "manhole_up": "manhole_483_generated", "manhole_dn": "manhole_484_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384757.405406558187678, 5858116.280495692044497 ], [ 1384746.211964494548738, 5858164.956996791996062 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E20", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 847.0, "invlev_up": 844.5, "invlev_dn": 844.5, "manhole_up": "manhole_484_generated", "manhole_dn": "manhole_485_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384746.211964494548738, 5858164.956996791996062 ], [ 1384738.028054837835953, 5858213.862443570047617 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E21", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 847.0, "invlev_up": 844.5, "invlev_dn": 844.5, "manhole_up": "manhole_485_generated", "manhole_dn": "manhole_486_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384738.028054837835953, 5858213.862443570047617 ], [ 1384756.479259133106098, 5858259.218586039729416 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E22", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 833.20001220703125, "invlev_up": 844.5, "invlev_dn": 830.70001220703125, "manhole_up": "manhole_486_generated", "manhole_dn": "manhole_487_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384756.479259133106098, 5858259.218586039729416 ], [ 1384792.653981153853238, 5858293.25339647103101 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E23", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 833.20001220703125, "elevtn_dn": 762.29998779296875, "invlev_up": 830.70001220703125, "invlev_dn": 759.79998779296875, "manhole_up": "manhole_487_generated", "manhole_dn": "manhole_488_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384792.653981153853238, 5858293.25339647103101 ], [ 1384839.146884107263759, 5858310.949097327888012 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E24", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.29998779296875, "elevtn_dn": 762.29998779296875, "invlev_up": 759.79998779296875, "invlev_dn": 759.79998779296875, "manhole_up": "manhole_488_generated", "manhole_dn": "manhole_489_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384839.146884107263759, 5858310.949097327888012 ], [ 1384888.517509665805846, 5858307.535864246077836 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E25", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.29998779296875, "elevtn_dn": 751.0, "invlev_up": 759.79998779296875, "invlev_dn": 748.5, "manhole_up": "manhole_489_generated", "manhole_dn": "manhole_490_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384888.517509665805846, 5858307.535864246077836 ], [ 1384936.622762819286436, 5858294.068231076002121 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E26", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.0, "elevtn_dn": 751.0, "invlev_up": 748.5, "invlev_dn": 748.5, "manhole_up": "manhole_490_generated", "manhole_dn": "manhole_491_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384936.622762819286436, 5858294.068231076002121 ], [ 1384984.637113286415115, 5858280.272530450485647 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E27", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.0, "elevtn_dn": 743.20001220703125, "invlev_up": 748.5, "invlev_dn": 740.70001220703125, "manhole_up": "manhole_491_generated", "manhole_dn": "manhole_492_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384984.637113286415115, 5858280.272530450485647 ], [ 1385032.633651287527755, 5858266.414710656739771 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E28", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 743.20001220703125, "elevtn_dn": 743.20001220703125, "invlev_up": 740.70001220703125, "invlev_dn": 740.70001220703125, "manhole_up": "manhole_492_generated", "manhole_dn": "manhole_493_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385032.633651287527755, 5858266.414710656739771 ], [ 1385081.886840383987874, 5858258.136644747108221 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E29", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 743.20001220703125, "elevtn_dn": 747.60003662109375, "invlev_up": 740.70001220703125, "invlev_dn": 745.10003662109375, "manhole_up": "manhole_493_generated", "manhole_dn": "manhole_494_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385081.886840383987874, 5858258.136644747108221 ], [ 1385131.310463621048257, 5858263.211211345158517 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E30", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.60003662109375, "elevtn_dn": 756.79998779296875, "invlev_up": 745.10003662109375, "invlev_dn": 754.29998779296875, "manhole_up": "manhole_494_generated", "manhole_dn": "manhole_495_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385131.310463621048257, 5858263.211211345158517 ], [ 1385177.729395114118233, 5858281.168494092300534 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E31", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.79998779296875, "elevtn_dn": 758.9000244140625, "invlev_up": 754.29998779296875, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_495_generated", "manhole_dn": "manhole_496_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385177.729395114118233, 5858281.168494092300534 ], [ 1385219.95651927171275, 5858307.84242575801909 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E32", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 758.9000244140625, "invlev_up": 756.4000244140625, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_496_generated", "manhole_dn": "manhole_497_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385219.95651927171275, 5858307.84242575801909 ], [ 1385261.864506913116202, 5858335.034840167500079 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E33", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 756.29998779296875, "invlev_up": 756.4000244140625, "invlev_dn": 753.79998779296875, "manhole_up": "manhole_497_generated", "manhole_dn": "manhole_498_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385261.864506913116202, 5858335.034840167500079 ], [ 1385305.658712412696332, 5858358.964500648900867 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E34", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 756.29998779296875, "invlev_up": 753.79998779296875, "invlev_dn": 753.79998779296875, "manhole_up": "manhole_498_generated", "manhole_dn": "manhole_499_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385305.658712412696332, 5858358.964500648900867 ], [ 1385350.136275847908109, 5858381.712097893469036 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E35", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 750.79998779296875, "invlev_up": 753.79998779296875, "invlev_dn": 748.29998779296875, "manhole_up": "manhole_499_generated", "manhole_dn": "manhole_500_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385350.136275847908109, 5858381.712097893469036 ], [ 1385394.617425152566284, 5858404.452682325616479 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E36", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 750.79998779296875, "elevtn_dn": 760.20001220703125, "invlev_up": 748.29998779296875, "invlev_dn": 757.70001220703125, "manhole_up": "manhole_500_generated", "manhole_dn": "manhole_501_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385394.617425152566284, 5858404.452682325616479 ], [ 1385439.245915542822331, 5858426.901898948475718 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E37", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 760.20001220703125, "elevtn_dn": 754.29998779296875, "invlev_up": 757.70001220703125, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_501_generated", "manhole_dn": "manhole_502_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385439.245915542822331, 5858426.901898948475718 ], [ 1385483.926139793125913, 5858449.248809035867453 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E38", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 754.29998779296875, "invlev_up": 751.79998779296875, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_502_generated", "manhole_dn": "manhole_503_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385483.926139793125913, 5858449.248809035867453 ], [ 1385525.860647091642022, 5858475.8632338559255 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E39", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 754.29998779296875, "invlev_up": 751.79998779296875, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_503_generated", "manhole_dn": "manhole_504_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385525.860647091642022, 5858475.8632338559255 ], [ 1385553.357332118786871, 5858517.404887572862208 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E40", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 751.70001220703125, "invlev_up": 751.79998779296875, "invlev_dn": 749.20001220703125, "manhole_up": "manhole_504_generated", "manhole_dn": "manhole_505_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385553.357332118786871, 5858517.404887572862208 ], [ 1385579.617479301057756, 5858559.686364834196866 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E41", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.70001220703125, "elevtn_dn": 751.70001220703125, "invlev_up": 749.20001220703125, "invlev_dn": 749.20001220703125, "manhole_up": "manhole_505_generated", "manhole_dn": "manhole_506_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385579.617479301057756, 5858559.686364834196866 ], [ 1385621.905693766893819, 5858585.068030893802643 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E42", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.70001220703125, "elevtn_dn": 750.9000244140625, "invlev_up": 749.20001220703125, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_506_generated", "manhole_dn": "manhole_507_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385621.905693766893819, 5858585.068030893802643 ], [ 1385664.027273919200525, 5858611.351026647724211 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E43", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 750.9000244140625, "invlev_up": 748.4000244140625, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_507_generated", "manhole_dn": "manhole_508_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385664.027273919200525, 5858611.351026647724211 ], [ 1385700.387205619364977, 5858645.507954810746014 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E44", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 750.9000244140625, "invlev_up": 748.4000244140625, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_508_generated", "manhole_dn": "manhole_509_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385700.387205619364977, 5858645.507954810746014 ], [ 1385734.601841112133116, 5858681.909404612146318 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E45", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 755.79998779296875, "invlev_up": 748.4000244140625, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_509_generated", "manhole_dn": "manhole_510_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385734.601841112133116, 5858681.909404612146318 ], [ 1385768.816476604901254, 5858718.310854412615299 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E46", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_510_generated", "manhole_dn": "manhole_511_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385768.816476604901254, 5858718.310854412615299 ], [ 1385802.200311921536922, 5858755.447309947572649 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_20_E47", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_511_generated", "manhole_dn": "manhole_512_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385802.200311921536922, 5858755.447309947572649 ], [ 1385834.15946239954792, 5858793.844178703613579 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_21_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_21", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 765.0, "invlev_up": 753.79998779296875, "invlev_dn": 762.5, "manhole_up": "manhole_513_generated", "manhole_dn": "manhole_514_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385352.471788094611838, 5858398.70255031902343 ], [ 1385323.609449510695413, 5858430.098599229939282 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_21_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_21", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 765.0, "elevtn_dn": 765.0, "invlev_up": 762.5, "invlev_dn": 762.5, "manhole_up": "manhole_514_generated", "manhole_dn": "manhole_515_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385323.609449510695413, 5858430.098599229939282 ], [ 1385286.388775944709778, 5858419.306091710925102 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_21_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_21", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 765.0, "elevtn_dn": 758.9000244140625, "invlev_up": 762.5, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_515_generated", "manhole_dn": "manhole_516_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385286.388775944709778, 5858419.306091710925102 ], [ 1385252.458742934046313, 5858394.201654580421746 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_21_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_21", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 758.9000244140625, "invlev_up": 756.4000244140625, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_516_generated", "manhole_dn": "manhole_517_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385252.458742934046313, 5858394.201654580421746 ], [ 1385217.536378393415362, 5858369.72360460460186 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_21_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_21", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 756.79998779296875, "invlev_up": 756.4000244140625, "invlev_dn": 754.29998779296875, "manhole_up": "manhole_517_generated", "manhole_dn": "manhole_518_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385217.536378393415362, 5858369.72360460460186 ], [ 1385177.877519500209019, 5858363.975667187944055 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_23_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_23", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "manhole_up": "manhole_519_generated", "manhole_dn": "manhole_520_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384748.107251951703802, 5858475.46539437584579 ], [ 1384773.662756133358926, 5858482.028828926384449 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_23_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_23", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "manhole_up": "manhole_520_generated", "manhole_dn": "manhole_521_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384773.662756133358926, 5858482.028828926384449 ], [ 1384799.21826031524688, 5858488.592263477854431 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_24_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_24", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_24", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.9000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 760.4000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_522_generated", "manhole_dn": "manhole_523_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385831.554474999429658, 5858837.476550582796335 ], [ 1385834.933234154479578, 5858795.367517679929733 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_24_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_24", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_24", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 748.9000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_523_generated", "manhole_dn": "manhole_524_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385834.933234154479578, 5858795.367517679929733 ], [ 1385855.640895856311545, 5858836.135079927742481 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_25_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_25", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.79998779296875, "elevtn_dn": 791.20001220703125, "invlev_up": 784.29998779296875, "invlev_dn": 788.70001220703125, "manhole_up": "manhole_525_generated", "manhole_dn": "manhole_526_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385425.871741503709927, 5858809.522038951516151 ], [ 1385446.216239683330059, 5858844.397748519666493 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_25_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_25", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 791.20001220703125, "elevtn_dn": 791.20001220703125, "invlev_up": 788.70001220703125, "invlev_dn": 788.70001220703125, "manhole_up": "manhole_526_generated", "manhole_dn": "manhole_527_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385446.216239683330059, 5858844.397748519666493 ], [ 1385453.998638280900195, 5858886.437654017470777 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_25_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_25", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 791.20001220703125, "elevtn_dn": 783.0, "invlev_up": 788.70001220703125, "invlev_dn": 780.5, "manhole_up": "manhole_527_generated", "manhole_dn": "manhole_528_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385453.998638280900195, 5858886.437654017470777 ], [ 1385472.218053022632375, 5858925.273072509095073 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_26_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_26", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_26", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.9000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 760.4000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_522_generated", "manhole_dn": "manhole_524_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385831.554474999429658, 5858837.476550582796335 ], [ 1385855.640895856311545, 5858836.135079927742481 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_29_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_29", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_29", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_529_generated", "manhole_dn": "manhole_530_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385861.372513797832653, 5858893.832569030113518 ], [ 1385844.630084188189358, 5858865.848266057670116 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_29_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_29", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_29", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 762.9000244140625, "invlev_up": 757.20001220703125, "invlev_dn": 760.4000244140625, "manhole_up": "manhole_530_generated", "manhole_dn": "manhole_522_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385844.630084188189358, 5858865.848266057670116 ], [ 1385831.554474999429658, 5858837.476550582796335 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_30_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 769.4000244140625, "invlev_up": 766.9000244140625, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_531_generated", "manhole_dn": "manhole_532_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387137.22300889948383, 5858981.723106959834695 ], [ 1387148.04859330272302, 5859026.366797789931297 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_30_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 762.60003662109375, "invlev_up": 766.9000244140625, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_532_generated", "manhole_dn": "manhole_533_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387148.04859330272302, 5859026.366797789931297 ], [ 1387119.95937648974359, 5859056.934598693624139 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_30_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 762.60003662109375, "invlev_up": 760.10003662109375, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_533_generated", "manhole_dn": "manhole_534_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387119.95937648974359, 5859056.934598693624139 ], [ 1387074.832296247361228, 5859065.30100557859987 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_30_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 755.79998779296875, "invlev_up": 760.10003662109375, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_534_generated", "manhole_dn": "manhole_535_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387074.832296247361228, 5859065.30100557859987 ], [ 1387030.356415221933275, 5859076.86137125454843 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_30_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 772.4000244140625, "invlev_up": 753.29998779296875, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_535_generated", "manhole_dn": "manhole_536_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387030.356415221933275, 5859076.86137125454843 ], [ 1386986.427998587489128, 5859090.309648380614817 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_30_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 761.60003662109375, "invlev_up": 769.9000244140625, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_536_generated", "manhole_dn": "manhole_537_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386986.427998587489128, 5859090.309648380614817 ], [ 1386945.966695382725447, 5859111.788386604748666 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_30_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_537_generated", "manhole_dn": "manhole_538_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386945.966695382725447, 5859111.788386604748666 ], [ 1386905.77102447184734, 5859134.105928846634924 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_30_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_538_generated", "manhole_dn": "manhole_539_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386905.77102447184734, 5859134.105928846634924 ], [ 1386871.537448140559718, 5859162.609670763835311 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_539_generated", "manhole_dn": "manhole_540_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386871.537448140559718, 5859162.609670763835311 ], [ 1386921.106019288301468, 5859163.103915391489863 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 772.4000244140625, "invlev_up": 759.10003662109375, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_540_generated", "manhole_dn": "manhole_541_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386921.106019288301468, 5859163.103915391489863 ], [ 1386970.627896018791944, 5859161.624508504755795 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 772.4000244140625, "invlev_up": 769.9000244140625, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_541_generated", "manhole_dn": "manhole_542_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386970.627896018791944, 5859161.624508504755795 ], [ 1387019.993600395740941, 5859157.412991388700902 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 781.10003662109375, "invlev_up": 769.9000244140625, "invlev_dn": 778.60003662109375, "manhole_up": "manhole_542_generated", "manhole_dn": "manhole_543_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387019.993600395740941, 5859157.412991388700902 ], [ 1387069.191225855611265, 5859151.340004274621606 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 781.10003662109375, "elevtn_dn": 781.10003662109375, "invlev_up": 778.60003662109375, "invlev_dn": 778.60003662109375, "manhole_up": "manhole_543_generated", "manhole_dn": "manhole_544_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387069.191225855611265, 5859151.340004274621606 ], [ 1387118.547863835236058, 5859146.828392788767815 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 781.10003662109375, "elevtn_dn": 786.4000244140625, "invlev_up": 778.60003662109375, "invlev_dn": 783.9000244140625, "manhole_up": "manhole_544_generated", "manhole_dn": "manhole_545_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387118.547863835236058, 5859146.828392788767815 ], [ 1387167.916038708761334, 5859151.025294326245785 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.4000244140625, "elevtn_dn": 786.4000244140625, "invlev_up": 783.9000244140625, "invlev_dn": 783.9000244140625, "manhole_up": "manhole_545_generated", "manhole_dn": "manhole_546_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387167.916038708761334, 5859151.025294326245785 ], [ 1387217.282604865729809, 5859155.523034786805511 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.4000244140625, "elevtn_dn": 787.60003662109375, "invlev_up": 783.9000244140625, "invlev_dn": 785.10003662109375, "manhole_up": "manhole_546_generated", "manhole_dn": "manhole_547_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387217.282604865729809, 5859155.523034786805511 ], [ 1387266.649171022465453, 5859160.020775248296559 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E8", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 787.60003662109375, "elevtn_dn": 787.60003662109375, "invlev_up": 785.10003662109375, "invlev_dn": 785.10003662109375, "manhole_up": "manhole_547_generated", "manhole_dn": "manhole_548_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387266.649171022465453, 5859160.020775248296559 ], [ 1387315.831188223091885, 5859165.716172898188233 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E9", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 787.60003662109375, "elevtn_dn": 790.4000244140625, "invlev_up": 785.10003662109375, "invlev_dn": 787.9000244140625, "manhole_up": "manhole_548_generated", "manhole_dn": "manhole_549_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387315.831188223091885, 5859165.716172898188233 ], [ 1387364.261764668161049, 5859176.288154195994139 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E10", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 790.4000244140625, "elevtn_dn": 790.4000244140625, "invlev_up": 787.9000244140625, "invlev_dn": 787.9000244140625, "manhole_up": "manhole_549_generated", "manhole_dn": "manhole_550_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387364.261764668161049, 5859176.288154195994139 ], [ 1387411.186259990092367, 5859192.118345031514764 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E11", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 790.4000244140625, "elevtn_dn": 789.10003662109375, "invlev_up": 787.9000244140625, "invlev_dn": 786.60003662109375, "manhole_up": "manhole_550_generated", "manhole_dn": "manhole_551_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387411.186259990092367, 5859192.118345031514764 ], [ 1387455.544592748628929, 5859213.906051598489285 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E12", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 789.10003662109375, "elevtn_dn": 817.20001220703125, "invlev_up": 786.60003662109375, "invlev_dn": 814.70001220703125, "manhole_up": "manhole_551_generated", "manhole_dn": "manhole_552_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387455.544592748628929, 5859213.906051598489285 ], [ 1387490.610425172373652, 5859248.94134864397347 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E13", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 817.20001220703125, "elevtn_dn": 818.20001220703125, "invlev_up": 814.70001220703125, "invlev_dn": 815.70001220703125, "manhole_up": "manhole_552_generated", "manhole_dn": "manhole_553_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387490.610425172373652, 5859248.94134864397347 ], [ 1387525.979065561201423, 5859283.669168318621814 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E14", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 818.20001220703125, "elevtn_dn": 818.20001220703125, "invlev_up": 815.70001220703125, "invlev_dn": 815.70001220703125, "manhole_up": "manhole_553_generated", "manhole_dn": "manhole_554_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387525.979065561201423, 5859283.669168318621814 ], [ 1387563.532416822388768, 5859316.0270627560094 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E15", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 818.20001220703125, "elevtn_dn": 802.79998779296875, "invlev_up": 815.70001220703125, "invlev_dn": 800.29998779296875, "manhole_up": "manhole_554_generated", "manhole_dn": "manhole_555_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387563.532416822388768, 5859316.0270627560094 ], [ 1387601.085768083808944, 5859348.384957193396986 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E16", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 802.79998779296875, "elevtn_dn": 837.70001220703125, "invlev_up": 800.29998779296875, "invlev_dn": 835.20001220703125, "manhole_up": "manhole_555_generated", "manhole_dn": "manhole_556_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387601.085768083808944, 5859348.384957193396986 ], [ 1387638.639119345229119, 5859380.742851630784571 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E17", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 837.70001220703125, "elevtn_dn": 837.70001220703125, "invlev_up": 835.20001220703125, "invlev_dn": 835.20001220703125, "manhole_up": "manhole_556_generated", "manhole_dn": "manhole_557_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387638.639119345229119, 5859380.742851630784571 ], [ 1387676.192470606416464, 5859413.100746068172157 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E18", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 837.70001220703125, "elevtn_dn": 828.79998779296875, "invlev_up": 835.20001220703125, "invlev_dn": 826.29998779296875, "manhole_up": "manhole_557_generated", "manhole_dn": "manhole_558_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387676.192470606416464, 5859413.100746068172157 ], [ 1387713.745821867836639, 5859445.45864050462842 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E19", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 828.79998779296875, "elevtn_dn": 828.79998779296875, "invlev_up": 826.29998779296875, "invlev_dn": 826.29998779296875, "manhole_up": "manhole_558_generated", "manhole_dn": "manhole_559_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387713.745821867836639, 5859445.45864050462842 ], [ 1387750.394377880264074, 5859478.825171477161348 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E20", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 828.79998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 826.29998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_559_generated", "manhole_dn": "manhole_560_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387750.394377880264074, 5859478.825171477161348 ], [ 1387786.626276910537854, 5859512.656178202480078 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E21", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 851.79998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_560_generated", "manhole_dn": "manhole_561_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387786.626276910537854, 5859512.656178202480078 ], [ 1387822.858175940578803, 5859546.487184926867485 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E22", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 851.79998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_561_generated", "manhole_dn": "manhole_562_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387822.858175940578803, 5859546.487184926867485 ], [ 1387850.662340233800933, 5859586.980695966631174 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E23", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 891.20001220703125, "invlev_up": 851.79998779296875, "invlev_dn": 888.70001220703125, "manhole_up": "manhole_562_generated", "manhole_dn": "manhole_563_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387850.662340233800933, 5859586.980695966631174 ], [ 1387868.193221996771172, 5859633.330900657922029 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E24", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 891.20001220703125, "elevtn_dn": 876.20001220703125, "invlev_up": 888.70001220703125, "invlev_dn": 873.70001220703125, "manhole_up": "manhole_563_generated", "manhole_dn": "manhole_564_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387868.193221996771172, 5859633.330900657922029 ], [ 1387885.535610173596069, 5859679.769344814121723 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E25", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 876.20001220703125, "elevtn_dn": 876.20001220703125, "invlev_up": 873.70001220703125, "invlev_dn": 873.70001220703125, "manhole_up": "manhole_564_generated", "manhole_dn": "manhole_565_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387885.535610173596069, 5859679.769344814121723 ], [ 1387902.854485532967374, 5859726.216552678495646 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E26", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 876.20001220703125, "elevtn_dn": 898.29998779296875, "invlev_up": 873.70001220703125, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_565_generated", "manhole_dn": "manhole_566_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387902.854485532967374, 5859726.216552678495646 ], [ 1387920.137465380365029, 5859772.67713953461498 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E27", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 898.29998779296875, "invlev_up": 895.79998779296875, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_566_generated", "manhole_dn": "manhole_567_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387920.137465380365029, 5859772.67713953461498 ], [ 1387937.420445227529854, 5859819.137726389802992 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E28", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 898.29998779296875, "invlev_up": 895.79998779296875, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_567_generated", "manhole_dn": "manhole_568_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387937.420445227529854, 5859819.137726389802992 ], [ 1387948.863530882401392, 5859867.082766367122531 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E29", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 918.5, "invlev_up": 895.79998779296875, "invlev_dn": 916.0, "manhole_up": "manhole_568_generated", "manhole_dn": "manhole_569_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387948.863530882401392, 5859867.082766367122531 ], [ 1387950.013254075078294, 5859916.565449987538159 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E30", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 918.5, "invlev_up": 916.0, "invlev_dn": 916.0, "manhole_up": "manhole_569_generated", "manhole_dn": "manhole_570_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387950.013254075078294, 5859916.565449987538159 ], [ 1387947.430782878771424, 5859966.047936389222741 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E31", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 918.5, "invlev_up": 916.0, "invlev_dn": 916.0, "manhole_up": "manhole_570_generated", "manhole_dn": "manhole_571_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387947.430782878771424, 5859966.047936389222741 ], [ 1387943.997958281077445, 5860015.499966060742736 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E32", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 948.60003662109375, "invlev_up": 916.0, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_571_generated", "manhole_dn": "manhole_572_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387943.997958281077445, 5860015.499966060742736 ], [ 1387940.565133683150634, 5860064.951995733194053 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E33", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 948.60003662109375, "invlev_up": 946.10003662109375, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_572_generated", "manhole_dn": "manhole_573_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.565133683150634, 5860064.951995733194053 ], [ 1387945.371777657186612, 5860113.959104515612125 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E34", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 948.60003662109375, "invlev_up": 946.10003662109375, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_573_generated", "manhole_dn": "manhole_574_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387945.371777657186612, 5860113.959104515612125 ], [ 1387964.117816498270258, 5860159.736532494425774 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E35", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 940.5, "invlev_up": 946.10003662109375, "invlev_dn": 938.0, "manhole_up": "manhole_574_generated", "manhole_dn": "manhole_575_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387964.117816498270258, 5860159.736532494425774 ], [ 1387984.093857799191028, 5860205.104420888237655 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E36", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 940.5, "invlev_up": 938.0, "invlev_dn": 938.0, "manhole_up": "manhole_575_generated", "manhole_dn": "manhole_576_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387984.093857799191028, 5860205.104420888237655 ], [ 1388004.069899099878967, 5860250.472309282049537 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E37", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 940.5, "invlev_up": 938.0, "invlev_dn": 938.0, "manhole_up": "manhole_576_generated", "manhole_dn": "manhole_577_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388004.069899099878967, 5860250.472309282049537 ], [ 1388027.68692572391592, 5860293.896034284494817 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E38", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 971.70001220703125, "invlev_up": 938.0, "invlev_dn": 969.20001220703125, "manhole_up": "manhole_577_generated", "manhole_dn": "manhole_578_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388027.68692572391592, 5860293.896034284494817 ], [ 1388060.096315970877185, 5860331.348726416006684 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E39", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 971.70001220703125, "elevtn_dn": 935.5, "invlev_up": 969.20001220703125, "invlev_dn": 933.0, "manhole_up": "manhole_578_generated", "manhole_dn": "manhole_579_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388060.096315970877185, 5860331.348726416006684 ], [ 1388092.967688721138984, 5860368.453448176383972 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E40", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 935.5, "invlev_up": 933.0, "invlev_dn": 933.0, "manhole_up": "manhole_579_generated", "manhole_dn": "manhole_580_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388092.967688721138984, 5860368.453448176383972 ], [ 1388119.020827289205045, 5860410.510251956991851 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E41", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 949.9000244140625, "invlev_up": 933.0, "invlev_dn": 947.4000244140625, "manhole_up": "manhole_580_generated", "manhole_dn": "manhole_581_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388119.020827289205045, 5860410.510251956991851 ], [ 1388143.407622833969072, 5860453.667774203233421 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E42", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 949.9000244140625, "elevtn_dn": 924.60003662109375, "invlev_up": 947.4000244140625, "invlev_dn": 922.10003662109375, "manhole_up": "manhole_581_generated", "manhole_dn": "manhole_582_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388143.407622833969072, 5860453.667774203233421 ], [ 1388167.794418378733099, 5860496.82529644947499 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E43", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 924.60003662109375, "elevtn_dn": 924.60003662109375, "invlev_up": 922.10003662109375, "invlev_dn": 922.10003662109375, "manhole_up": "manhole_582_generated", "manhole_dn": "manhole_583_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388167.794418378733099, 5860496.82529644947499 ], [ 1388187.41186453984119, 5860542.097804954275489 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E44", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 924.60003662109375, "elevtn_dn": 942.4000244140625, "invlev_up": 922.10003662109375, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_583_generated", "manhole_dn": "manhole_584_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388187.41186453984119, 5860542.097804954275489 ], [ 1388193.385166377527639, 5860591.251542154699564 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E45", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 942.4000244140625, "invlev_up": 939.9000244140625, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_584_generated", "manhole_dn": "manhole_585_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388193.385166377527639, 5860591.251542154699564 ], [ 1388198.812296225922182, 5860640.524595490656793 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E46", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 942.4000244140625, "invlev_up": 939.9000244140625, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_585_generated", "manhole_dn": "manhole_586_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388198.812296225922182, 5860640.524595490656793 ], [ 1388204.239426074549556, 5860689.7976488256827 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E47", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 955.0, "invlev_up": 939.9000244140625, "invlev_dn": 952.5, "manhole_up": "manhole_586_generated", "manhole_dn": "manhole_587_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388204.239426074549556, 5860689.7976488256827 ], [ 1388184.484932377934456, 5860730.700381714850664 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E48", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_587_generated", "manhole_dn": "manhole_588_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388184.484932377934456, 5860730.700381714850664 ], [ 1388159.550175313837826, 5860759.392759991809726 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E49", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_588_generated", "manhole_dn": "manhole_589_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388159.550175313837826, 5860759.392759991809726 ], [ 1388171.988544700434431, 5860807.377908634953201 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E50", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_589_generated", "manhole_dn": "manhole_590_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388171.988544700434431, 5860807.377908634953201 ], [ 1388215.013825689908117, 5860825.214942933060229 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E51", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 941.10003662109375, "invlev_up": 952.5, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_590_generated", "manhole_dn": "manhole_591_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388215.013825689908117, 5860825.214942933060229 ], [ 1388264.397385431453586, 5860829.298032846301794 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E52", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_591_generated", "manhole_dn": "manhole_592_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388264.397385431453586, 5860829.298032846301794 ], [ 1388313.062299854354933, 5860837.304878970608115 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E53", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 937.5, "invlev_up": 938.60003662109375, "invlev_dn": 935.0, "manhole_up": "manhole_592_generated", "manhole_dn": "manhole_593_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388313.062299854354933, 5860837.304878970608115 ], [ 1388360.993895401246846, 5860849.948045967146754 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E54", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.5, "elevtn_dn": 937.5, "invlev_up": 935.0, "invlev_dn": 935.0, "manhole_up": "manhole_593_generated", "manhole_dn": "manhole_594_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388360.993895401246846, 5860849.948045967146754 ], [ 1388408.925490947905928, 5860862.591212964616716 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E55", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.5, "elevtn_dn": 937.60003662109375, "invlev_up": 935.0, "invlev_dn": 935.10003662109375, "manhole_up": "manhole_594_generated", "manhole_dn": "manhole_595_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388408.925490947905928, 5860862.591212964616716 ], [ 1388458.220990223577246, 5860866.957201769575477 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E56", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.60003662109375, "elevtn_dn": 937.60003662109375, "invlev_up": 935.10003662109375, "invlev_dn": 935.10003662109375, "manhole_up": "manhole_595_generated", "manhole_dn": "manhole_596_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388458.220990223577246, 5860866.957201769575477 ], [ 1388507.336333080893382, 5860873.218384950421751 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E57", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.60003662109375, "elevtn_dn": 941.20001220703125, "invlev_up": 935.10003662109375, "invlev_dn": 938.70001220703125, "manhole_up": "manhole_596_generated", "manhole_dn": "manhole_597_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388507.336333080893382, 5860873.218384950421751 ], [ 1388556.215695114107803, 5860881.470384138636291 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E58", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.20001220703125, "elevtn_dn": 941.20001220703125, "invlev_up": 938.70001220703125, "invlev_dn": 938.70001220703125, "manhole_up": "manhole_597_generated", "manhole_dn": "manhole_598_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388556.215695114107803, 5860881.470384138636291 ], [ 1388604.556662159739062, 5860892.361969010904431 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E59", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.20001220703125, "elevtn_dn": 943.10003662109375, "invlev_up": 938.70001220703125, "invlev_dn": 940.60003662109375, "manhole_up": "manhole_598_generated", "manhole_dn": "manhole_599_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388604.556662159739062, 5860892.361969010904431 ], [ 1388653.59940263046883, 5860897.15789801068604 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E60", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 943.10003662109375, "elevtn_dn": 943.10003662109375, "invlev_up": 940.60003662109375, "invlev_dn": 940.60003662109375, "manhole_up": "manhole_599_generated", "manhole_dn": "manhole_600_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388653.59940263046883, 5860897.15789801068604 ], [ 1388700.080393208190799, 5860881.090511013753712 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E61", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 943.10003662109375, "elevtn_dn": 946.10003662109375, "invlev_up": 940.60003662109375, "invlev_dn": 943.60003662109375, "manhole_up": "manhole_600_generated", "manhole_dn": "manhole_601_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388700.080393208190799, 5860881.090511013753712 ], [ 1388732.687003659084439, 5860844.794781206175685 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E62", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 946.10003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 943.60003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_601_generated", "manhole_dn": "manhole_602_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388732.687003659084439, 5860844.794781206175685 ], [ 1388755.953327334951609, 5860801.023035684600472 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E63", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 950.10003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_602_generated", "manhole_dn": "manhole_603_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388755.953327334951609, 5860801.023035684600472 ], [ 1388778.23369869007729, 5860756.84024004638195 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E64", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 950.10003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_603_generated", "manhole_dn": "manhole_604_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388778.23369869007729, 5860756.84024004638195 ], [ 1388792.950793598080054, 5860709.504263866692781 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E65", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 953.79998779296875, "invlev_up": 950.10003662109375, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_604_generated", "manhole_dn": "manhole_605_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388792.950793598080054, 5860709.504263866692781 ], [ 1388807.667888506315649, 5860662.168287687934935 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E66", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_605_generated", "manhole_dn": "manhole_606_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388807.667888506315649, 5860662.168287687934935 ], [ 1388819.224422588944435, 5860613.968191100284457 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E67", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 955.70001220703125, "invlev_up": 951.29998779296875, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_606_generated", "manhole_dn": "manhole_607_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388819.224422588944435, 5860613.968191100284457 ], [ 1388830.63825476472266, 5860565.72907877061516 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E68", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_607_generated", "manhole_dn": "manhole_608_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388830.63825476472266, 5860565.72907877061516 ], [ 1388842.052086940500885, 5860517.489966440014541 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E69", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_608_generated", "manhole_dn": "manhole_609_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388842.052086940500885, 5860517.489966440014541 ], [ 1388862.77624000934884, 5860472.578981296159327 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E70", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 964.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_609_generated", "manhole_dn": "manhole_610_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388862.77624000934884, 5860472.578981296159327 ], [ 1388884.529400010826066, 5860428.03588358964771 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E71", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 951.29998779296875, "invlev_up": 962.20001220703125, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_610_generated", "manhole_dn": "manhole_611_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388884.529400010826066, 5860428.03588358964771 ], [ 1388906.282637836178765, 5860383.492823889479041 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E72", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_611_generated", "manhole_dn": "manhole_612_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388906.282637836178765, 5860383.492823889479041 ], [ 1388933.946375871310011, 5860342.419800435192883 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_32_E73", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_612_generated", "manhole_dn": "manhole_613_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388933.946375871310011, 5860342.419800435192883 ], [ 1388962.240715913940221, 5860301.717001453973353 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_33_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 752.29998779296875, "invlev_up": 759.10003662109375, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_539_generated", "manhole_dn": "manhole_614_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386871.537448140559718, 5859162.609670763835311 ], [ 1386825.19834817154333, 5859175.156894122250378 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_33_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 752.29998779296875, "invlev_up": 749.79998779296875, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_614_generated", "manhole_dn": "manhole_615_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386825.19834817154333, 5859175.156894122250378 ], [ 1386779.333999397465959, 5859189.44842192158103 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_33_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 738.0, "invlev_up": 749.79998779296875, "invlev_dn": 735.5, "manhole_up": "manhole_615_generated", "manhole_dn": "manhole_616_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386779.333999397465959, 5859189.44842192158103 ], [ 1386733.445003136992455, 5859203.660136871039867 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_33_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 738.0, "invlev_up": 735.5, "invlev_dn": 735.5, "manhole_up": "manhole_616_generated", "manhole_dn": "manhole_617_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386733.445003136992455, 5859203.660136871039867 ], [ 1386687.508546756347641, 5859217.718167688697577 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_33_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 763.29998779296875, "invlev_up": 735.5, "invlev_dn": 760.79998779296875, "manhole_up": "manhole_617_generated", "manhole_dn": "manhole_618_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386687.508546756347641, 5859217.718167688697577 ], [ 1386641.572090375469998, 5859231.776198507286608 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_33_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 763.29998779296875, "elevtn_dn": 763.29998779296875, "invlev_up": 760.79998779296875, "invlev_dn": 760.79998779296875, "manhole_up": "manhole_618_generated", "manhole_dn": "manhole_619_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386641.572090375469998, 5859231.776198507286608 ], [ 1386595.451642262749374, 5859245.168246414512396 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_33_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 763.29998779296875, "elevtn_dn": 754.60003662109375, "invlev_up": 760.79998779296875, "invlev_dn": 752.10003662109375, "manhole_up": "manhole_619_generated", "manhole_dn": "manhole_620_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386595.451642262749374, 5859245.168246414512396 ], [ 1386548.813360751140863, 5859256.685926430858672 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_33_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 754.60003662109375, "elevtn_dn": 754.60003662109375, "invlev_up": 752.10003662109375, "invlev_dn": 752.10003662109375, "manhole_up": "manhole_620_generated", "manhole_dn": "manhole_621_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386548.813360751140863, 5859256.685926430858672 ], [ 1386502.175079239532351, 5859268.203606447204947 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_33_E8", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 754.60003662109375, "elevtn_dn": 742.5, "invlev_up": 752.10003662109375, "invlev_dn": 740.0, "manhole_up": "manhole_621_generated", "manhole_dn": "manhole_622_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386502.175079239532351, 5859268.203606447204947 ], [ 1386455.354356503346935, 5859278.943273726850748 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_33_E9", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 742.5, "invlev_up": 740.0, "invlev_dn": 740.0, "manhole_up": "manhole_622_generated", "manhole_dn": "manhole_623_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386455.354356503346935, 5859278.943273726850748 ], [ 1386408.879239794565365, 5859290.671229789964855 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_33_E10", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 717.60003662109375, "invlev_up": 740.0, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_623_generated", "manhole_dn": "manhole_624_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386408.879239794565365, 5859290.671229789964855 ], [ 1386364.691368696978316, 5859309.518465746194124 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_33_E11", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 717.60003662109375, "invlev_up": 715.10003662109375, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_624_generated", "manhole_dn": "manhole_625_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386364.691368696978316, 5859309.518465746194124 ], [ 1386320.503497599391267, 5859328.365701701492071 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_33_E12", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 711.0, "invlev_up": 715.10003662109375, "invlev_dn": 708.5, "manhole_up": "manhole_625_generated", "manhole_dn": "manhole_626_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386320.503497599391267, 5859328.365701701492071 ], [ 1386273.173811787506565, 5859335.36546028777957 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 953.70001220703125, "invlev_up": 948.79998779296875, "invlev_dn": 951.20001220703125, "manhole_up": "manhole_10_generated", "manhole_dn": "manhole_627_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388946.301100668497384, 5860414.883977899327874 ], [ 1388922.246059404918924, 5860458.418739438988268 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.70001220703125, "elevtn_dn": 953.70001220703125, "invlev_up": 951.20001220703125, "invlev_dn": 951.20001220703125, "manhole_up": "manhole_627_generated", "manhole_dn": "manhole_628_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388922.246059404918924, 5860458.418739438988268 ], [ 1388900.295977992936969, 5860503.075897979550064 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 951.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_628_generated", "manhole_dn": "manhole_629_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388900.295977992936969, 5860503.075897979550064 ], [ 1388878.345896581187844, 5860547.733056520111859 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 953.79998779296875, "invlev_up": 953.20001220703125, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_629_generated", "manhole_dn": "manhole_630_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388878.345896581187844, 5860547.733056520111859 ], [ 1388856.887740465346724, 5860592.570927501656115 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_630_generated", "manhole_dn": "manhole_631_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388856.887740465346724, 5860592.570927501656115 ], [ 1388853.076019846601412, 5860641.795407227240503 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_631_generated", "manhole_dn": "manhole_632_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388853.076019846601412, 5860641.795407227240503 ], [ 1388856.119826921960339, 5860691.462329030036926 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 952.5, "invlev_up": 951.29998779296875, "invlev_dn": 950.0, "manhole_up": "manhole_632_generated", "manhole_dn": "manhole_633_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388856.119826921960339, 5860691.462329030036926 ], [ 1388859.163633997086436, 5860741.12925083283335 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.5, "elevtn_dn": 952.5, "invlev_up": 950.0, "invlev_dn": 950.0, "manhole_up": "manhole_633_generated", "manhole_dn": "manhole_634_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388859.163633997086436, 5860741.12925083283335 ], [ 1388862.207441072445363, 5860790.796172635629773 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E8", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.5, "elevtn_dn": 945.5, "invlev_up": 950.0, "invlev_dn": 943.0, "manhole_up": "manhole_634_generated", "manhole_dn": "manhole_635_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388862.207441072445363, 5860790.796172635629773 ], [ 1388866.356326055014506, 5860840.344227194786072 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E9", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 945.5, "invlev_up": 943.0, "invlev_dn": 943.0, "manhole_up": "manhole_635_generated", "manhole_dn": "manhole_636_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388866.356326055014506, 5860840.344227194786072 ], [ 1388873.944740658160299, 5860889.522310186177492 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E10", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 945.5, "invlev_up": 943.0, "invlev_dn": 943.0, "manhole_up": "manhole_636_generated", "manhole_dn": "manhole_637_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388873.944740658160299, 5860889.522310186177492 ], [ 1388883.17427325528115, 5860938.398467163555324 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E11", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 937.4000244140625, "invlev_up": 943.0, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_637_generated", "manhole_dn": "manhole_638_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388883.17427325528115, 5860938.398467163555324 ], [ 1388890.216840920504183, 5860987.212368851527572 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E12", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 937.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_638_generated", "manhole_dn": "manhole_639_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388890.216840920504183, 5860987.212368851527572 ], [ 1388884.322194910608232, 5861036.62209493201226 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E13", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 937.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_639_generated", "manhole_dn": "manhole_640_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388884.322194910608232, 5861036.62209493201226 ], [ 1388878.427548900712281, 5861086.031821011565626 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E14", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_640_generated", "manhole_dn": "manhole_641_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388878.427548900712281, 5861086.031821011565626 ], [ 1388872.532902890816331, 5861135.441547092050314 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E15", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 927.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_641_generated", "manhole_dn": "manhole_642_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388872.532902890816331, 5861135.441547092050314 ], [ 1388866.63825688092038, 5861184.851273172535002 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E16", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 927.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_642_generated", "manhole_dn": "manhole_643_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388866.63825688092038, 5861184.851273172535002 ], [ 1388854.620840607210994, 5861232.489912945777178 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E17", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 926.60003662109375, "invlev_up": 927.9000244140625, "invlev_dn": 924.10003662109375, "manhole_up": "manhole_643_generated", "manhole_dn": "manhole_644_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388854.620840607210994, 5861232.489912945777178 ], [ 1388833.22756120422855, 5861277.416469449177384 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E18", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 926.60003662109375, "elevtn_dn": 926.60003662109375, "invlev_up": 924.10003662109375, "invlev_dn": 924.10003662109375, "manhole_up": "manhole_644_generated", "manhole_dn": "manhole_645_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388833.22756120422855, 5861277.416469449177384 ], [ 1388811.834281801246107, 5861322.343025953508914 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E19", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 926.60003662109375, "elevtn_dn": 931.10003662109375, "invlev_up": 924.10003662109375, "invlev_dn": 928.60003662109375, "manhole_up": "manhole_645_generated", "manhole_dn": "manhole_646_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388811.834281801246107, 5861322.343025953508914 ], [ 1388790.441002398030832, 5861367.26958245690912 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E20", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 931.10003662109375, "elevtn_dn": 922.20001220703125, "invlev_up": 928.60003662109375, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_646_generated", "manhole_dn": "manhole_647_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388790.441002398030832, 5861367.26958245690912 ], [ 1388769.047722995048389, 5861412.196138960309327 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E21", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 922.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_647_generated", "manhole_dn": "manhole_648_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388769.047722995048389, 5861412.196138960309327 ], [ 1388747.654443592065945, 5861457.122695464640856 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E22", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 922.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_648_generated", "manhole_dn": "manhole_649_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388747.654443592065945, 5861457.122695464640856 ], [ 1388725.026126575190574, 5861501.410491958260536 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E23", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_649_generated", "manhole_dn": "manhole_650_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388725.026126575190574, 5861501.410491958260536 ], [ 1388700.725248141447082, 5861544.833241644315422 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E24", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_650_generated", "manhole_dn": "manhole_651_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388700.725248141447082, 5861544.833241644315422 ], [ 1388676.42436970770359, 5861588.255991329438984 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E25", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_651_generated", "manhole_dn": "manhole_652_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388676.42436970770359, 5861588.255991329438984 ], [ 1388632.324464634526521, 5861606.441272142343223 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E26", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 898.4000244140625, "invlev_up": 897.70001220703125, "invlev_dn": 895.9000244140625, "manhole_up": "manhole_652_generated", "manhole_dn": "manhole_653_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388632.324464634526521, 5861606.441272142343223 ], [ 1388583.463808472501114, 5861611.105615227483213 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E27", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 898.4000244140625, "elevtn_dn": 898.4000244140625, "invlev_up": 895.9000244140625, "invlev_dn": 895.9000244140625, "manhole_up": "manhole_653_generated", "manhole_dn": "manhole_654_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388583.463808472501114, 5861611.105615227483213 ], [ 1388534.764012826373801, 5861604.222017968073487 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E28", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 898.4000244140625, "elevtn_dn": 903.60003662109375, "invlev_up": 895.9000244140625, "invlev_dn": 901.10003662109375, "manhole_up": "manhole_654_generated", "manhole_dn": "manhole_655_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388534.764012826373801, 5861604.222017968073487 ], [ 1388489.566489090910181, 5861583.40731808822602 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E29", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 903.60003662109375, "elevtn_dn": 903.60003662109375, "invlev_up": 901.10003662109375, "invlev_dn": 901.10003662109375, "manhole_up": "manhole_655_generated", "manhole_dn": "manhole_656_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388489.566489090910181, 5861583.40731808822602 ], [ 1388444.204915680922568, 5861563.162508152425289 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E30", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 903.60003662109375, "elevtn_dn": 906.4000244140625, "invlev_up": 901.10003662109375, "invlev_dn": 903.9000244140625, "manhole_up": "manhole_656_generated", "manhole_dn": "manhole_657_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388444.204915680922568, 5861563.162508152425289 ], [ 1388394.858231473481283, 5861556.761520680040121 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E31", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 906.4000244140625, "elevtn_dn": 906.4000244140625, "invlev_up": 903.9000244140625, "invlev_dn": 903.9000244140625, "manhole_up": "manhole_657_generated", "manhole_dn": "manhole_658_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388394.858231473481283, 5861556.761520680040121 ], [ 1388350.680838279658929, 5861570.408674017526209 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E32", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 906.4000244140625, "elevtn_dn": 900.20001220703125, "invlev_up": 903.9000244140625, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_658_generated", "manhole_dn": "manhole_659_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388350.680838279658929, 5861570.408674017526209 ], [ 1388310.581732882419601, 5861599.872713611461222 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E33", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_659_generated", "manhole_dn": "manhole_660_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388310.581732882419601, 5861599.872713611461222 ], [ 1388271.039625711739063, 5861629.969603477045894 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E34", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 890.0, "invlev_up": 897.70001220703125, "invlev_dn": 887.5, "manhole_up": "manhole_660_generated", "manhole_dn": "manhole_661_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388271.039625711739063, 5861629.969603477045894 ], [ 1388236.722210306907073, 5861666.002683873288333 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E35", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 890.0, "invlev_up": 887.5, "invlev_dn": 887.5, "manhole_up": "manhole_661_generated", "manhole_dn": "manhole_662_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388236.722210306907073, 5861666.002683873288333 ], [ 1388202.404794902307913, 5861702.035764269530773 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E36", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 890.0, "invlev_up": 887.5, "invlev_dn": 887.5, "manhole_up": "manhole_662_generated", "manhole_dn": "manhole_663_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388202.404794902307913, 5861702.035764269530773 ], [ 1388168.087379497475922, 5861738.068844665773213 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E37", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 885.9000244140625, "invlev_up": 887.5, "invlev_dn": 883.4000244140625, "manhole_up": "manhole_663_generated", "manhole_dn": "manhole_664_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388168.087379497475922, 5861738.068844665773213 ], [ 1388133.769964092643932, 5861774.101925062015653 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E38", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 885.9000244140625, "elevtn_dn": 874.0, "invlev_up": 883.4000244140625, "invlev_dn": 871.5, "manhole_up": "manhole_664_generated", "manhole_dn": "manhole_665_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388133.769964092643932, 5861774.101925062015653 ], [ 1388099.452548687811941, 5861810.13500545732677 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E39", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 874.0, "elevtn_dn": 874.0, "invlev_up": 871.5, "invlev_dn": 871.5, "manhole_up": "manhole_665_generated", "manhole_dn": "manhole_666_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388099.452548687811941, 5861810.13500545732677 ], [ 1388065.135133283212781, 5861846.16808585356921 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E40", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 874.0, "elevtn_dn": 862.20001220703125, "invlev_up": 871.5, "invlev_dn": 859.70001220703125, "manhole_up": "manhole_666_generated", "manhole_dn": "manhole_667_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388065.135133283212781, 5861846.16808585356921 ], [ 1388022.995196633273736, 5861866.899685021489859 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E41", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 862.20001220703125, "elevtn_dn": 862.20001220703125, "invlev_up": 859.70001220703125, "invlev_dn": 859.70001220703125, "manhole_up": "manhole_667_generated", "manhole_dn": "manhole_668_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388022.995196633273736, 5861866.899685021489859 ], [ 1387973.690499771386385, 5861873.616436487063766 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E42", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 862.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 859.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_668_generated", "manhole_dn": "manhole_669_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387973.690499771386385, 5861873.616436487063766 ], [ 1387924.470484273741022, 5861880.90659652557224 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E43", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_669_generated", "manhole_dn": "manhole_670_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387924.470484273741022, 5861880.90659652557224 ], [ 1387877.962616891367361, 5861896.157046243548393 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E44", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_670_generated", "manhole_dn": "manhole_671_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387877.962616891367361, 5861896.157046243548393 ], [ 1387917.070526217576116, 5861911.915829903446138 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E45", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_671_generated", "manhole_dn": "manhole_672_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387917.070526217576116, 5861911.915829903446138 ], [ 1387966.654667611001059, 5861916.096835186704993 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E46", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 846.29998779296875, "invlev_up": 856.70001220703125, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_672_generated", "manhole_dn": "manhole_673_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387966.654667611001059, 5861916.096835186704993 ], [ 1388016.318005530629307, 5861919.063731476664543 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E47", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 850.10003662109375, "invlev_up": 843.79998779296875, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_673_generated", "manhole_dn": "manhole_674_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388016.318005530629307, 5861919.063731476664543 ], [ 1388066.025120510486886, 5861921.359510923735797 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E48", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 850.10003662109375, "invlev_up": 847.60003662109375, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_674_generated", "manhole_dn": "manhole_675_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388066.025120510486886, 5861921.359510923735797 ], [ 1388115.732235490344465, 5861923.655290370807052 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E49", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 849.0, "invlev_up": 847.60003662109375, "invlev_dn": 846.5, "manhole_up": "manhole_675_generated", "manhole_dn": "manhole_676_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388115.732235490344465, 5861923.655290370807052 ], [ 1388161.130695321131498, 5861931.457672152668238 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E50", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 849.0, "elevtn_dn": 850.10003662109375, "invlev_up": 846.5, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_676_generated", "manhole_dn": "manhole_677_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388161.130695321131498, 5861931.457672152668238 ], [ 1388139.871223766123876, 5861964.082641129381955 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E51", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 850.10003662109375, "invlev_up": 847.60003662109375, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_677_generated", "manhole_dn": "manhole_678_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388139.871223766123876, 5861964.082641129381955 ], [ 1388090.726845995755866, 5861957.769498392008245 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E52", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 846.29998779296875, "invlev_up": 847.60003662109375, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_678_generated", "manhole_dn": "manhole_679_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388090.726845995755866, 5861957.769498392008245 ], [ 1388049.339104855433106, 5861983.736727176234126 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E53", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 846.29998779296875, "invlev_up": 843.79998779296875, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_679_generated", "manhole_dn": "manhole_680_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388049.339104855433106, 5861983.736727176234126 ], [ 1388024.713075590552762, 5862026.975905770435929 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E54", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 846.29998779296875, "invlev_up": 843.79998779296875, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_680_generated", "manhole_dn": "manhole_681_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388024.713075590552762, 5862026.975905770435929 ], [ 1387980.016218039905652, 5862047.702198376879096 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E55", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 793.5, "invlev_up": 843.79998779296875, "invlev_dn": 791.0, "manhole_up": "manhole_681_generated", "manhole_dn": "manhole_682_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387980.016218039905652, 5862047.702198376879096 ], [ 1387931.90673128189519, 5862056.853296543471515 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E56", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.5, "elevtn_dn": 793.5, "invlev_up": 791.0, "invlev_dn": 791.0, "manhole_up": "manhole_682_generated", "manhole_dn": "manhole_683_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387931.90673128189519, 5862056.853296543471515 ], [ 1387882.187313467729837, 5862058.865105460397899 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E57", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.5, "elevtn_dn": 793.20001220703125, "invlev_up": 791.0, "invlev_dn": 790.70001220703125, "manhole_up": "manhole_683_generated", "manhole_dn": "manhole_684_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387882.187313467729837, 5862058.865105460397899 ], [ 1387832.722497318405658, 5862057.3410848621279 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E58", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.20001220703125, "elevtn_dn": 830.29998779296875, "invlev_up": 790.70001220703125, "invlev_dn": 827.79998779296875, "manhole_up": "manhole_684_generated", "manhole_dn": "manhole_685_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387832.722497318405658, 5862057.3410848621279 ], [ 1387783.80423084856011, 5862048.226750630885363 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E59", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 830.29998779296875, "elevtn_dn": 817.70001220703125, "invlev_up": 827.79998779296875, "invlev_dn": 815.20001220703125, "manhole_up": "manhole_685_generated", "manhole_dn": "manhole_686_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387783.80423084856011, 5862048.226750630885363 ], [ 1387734.885964378714561, 5862039.112416399642825 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E60", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 817.70001220703125, "elevtn_dn": 813.70001220703125, "invlev_up": 815.20001220703125, "invlev_dn": 811.20001220703125, "manhole_up": "manhole_686_generated", "manhole_dn": "manhole_687_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387734.885964378714561, 5862039.112416399642825 ], [ 1387685.967697908869013, 5862029.998082168400288 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E61", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 813.70001220703125, "elevtn_dn": 813.70001220703125, "invlev_up": 811.20001220703125, "invlev_dn": 811.20001220703125, "manhole_up": "manhole_687_generated", "manhole_dn": "manhole_688_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387685.967697908869013, 5862029.998082168400288 ], [ 1387637.036115845199674, 5862020.957140567712486 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E62", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 813.70001220703125, "elevtn_dn": 807.0, "invlev_up": 811.20001220703125, "invlev_dn": 804.5, "manhole_up": "manhole_688_generated", "manhole_dn": "manhole_689_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387637.036115845199674, 5862020.957140567712486 ], [ 1387588.033849656581879, 5862012.305794355459511 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E63", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.0, "elevtn_dn": 807.0, "invlev_up": 804.5, "invlev_dn": 804.5, "manhole_up": "manhole_689_generated", "manhole_dn": "manhole_690_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387588.033849656581879, 5862012.305794355459511 ], [ 1387539.031583468196914, 5862003.654448143206537 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E64", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.0, "elevtn_dn": 793.10003662109375, "invlev_up": 804.5, "invlev_dn": 790.60003662109375, "manhole_up": "manhole_690_generated", "manhole_dn": "manhole_691_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387539.031583468196914, 5862003.654448143206537 ], [ 1387490.029317279579118, 5861995.003101930953562 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E65", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.10003662109375, "elevtn_dn": 793.10003662109375, "invlev_up": 790.60003662109375, "invlev_dn": 790.60003662109375, "manhole_up": "manhole_691_generated", "manhole_dn": "manhole_692_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387490.029317279579118, 5861995.003101930953562 ], [ 1387440.720367865404114, 5861989.908138634636998 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E66", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.10003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 790.60003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_692_generated", "manhole_dn": "manhole_693_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387440.720367865404114, 5861989.908138634636998 ], [ 1387390.960446665296331, 5861990.042768024839461 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E67", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_693_generated", "manhole_dn": "manhole_694_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387390.960446665296331, 5861990.042768024839461 ], [ 1387341.200525465421379, 5861990.177397414110601 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E68", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 749.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 747.10003662109375, "manhole_up": "manhole_694_generated", "manhole_dn": "manhole_695_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387341.200525465421379, 5861990.177397414110601 ], [ 1387291.440604265546426, 5861990.312026804313064 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E69", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 749.60003662109375, "elevtn_dn": 749.60003662109375, "invlev_up": 747.10003662109375, "invlev_dn": 747.10003662109375, "manhole_up": "manhole_695_generated", "manhole_dn": "manhole_696_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387291.440604265546426, 5861990.312026804313064 ], [ 1387246.706285298336297, 5861974.212805554270744 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E70", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 749.60003662109375, "elevtn_dn": 747.0, "invlev_up": 747.10003662109375, "invlev_dn": 744.5, "manhole_up": "manhole_696_generated", "manhole_dn": "manhole_697_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387246.706285298336297, 5861974.212805554270744 ], [ 1387205.725988702848554, 5861945.987228964455426 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E71", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.0, "elevtn_dn": 771.79998779296875, "invlev_up": 744.5, "invlev_dn": 769.29998779296875, "manhole_up": "manhole_697_generated", "manhole_dn": "manhole_698_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387205.725988702848554, 5861945.987228964455426 ], [ 1387164.745692107127979, 5861917.761652374640107 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E72", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.79998779296875, "elevtn_dn": 764.10003662109375, "invlev_up": 769.29998779296875, "invlev_dn": 761.60003662109375, "manhole_up": "manhole_698_generated", "manhole_dn": "manhole_699_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387164.745692107127979, 5861917.761652374640107 ], [ 1387115.569933785125613, 5861911.215812381356955 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E73", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 764.10003662109375, "elevtn_dn": 764.10003662109375, "invlev_up": 761.60003662109375, "invlev_dn": 761.60003662109375, "manhole_up": "manhole_699_generated", "manhole_dn": "manhole_700_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387115.569933785125613, 5861911.215812381356955 ], [ 1387066.165866439929232, 5861905.273926095105708 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E74", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 764.10003662109375, "elevtn_dn": 747.70001220703125, "invlev_up": 761.60003662109375, "invlev_dn": 745.20001220703125, "manhole_up": "manhole_700_generated", "manhole_dn": "manhole_701_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387066.165866439929232, 5861905.273926095105708 ], [ 1387016.666836149292067, 5861900.238133460283279 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E75", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.70001220703125, "elevtn_dn": 747.70001220703125, "invlev_up": 745.20001220703125, "invlev_dn": 745.20001220703125, "manhole_up": "manhole_701_generated", "manhole_dn": "manhole_702_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387016.666836149292067, 5861900.238133460283279 ], [ 1386975.698310127714649, 5861874.842493440955877 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E76", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.70001220703125, "elevtn_dn": 739.60003662109375, "invlev_up": 745.20001220703125, "invlev_dn": 737.10003662109375, "manhole_up": "manhole_702_generated", "manhole_dn": "manhole_703_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386975.698310127714649, 5861874.842493440955877 ], [ 1386937.286019780673087, 5861843.21080310922116 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E77", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 739.60003662109375, "elevtn_dn": 739.60003662109375, "invlev_up": 737.10003662109375, "invlev_dn": 737.10003662109375, "manhole_up": "manhole_703_generated", "manhole_dn": "manhole_704_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386937.286019780673087, 5861843.21080310922116 ], [ 1386898.873729433864355, 5861811.579112778417766 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E78", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 739.60003662109375, "elevtn_dn": 755.20001220703125, "invlev_up": 737.10003662109375, "invlev_dn": 752.70001220703125, "manhole_up": "manhole_704_generated", "manhole_dn": "manhole_705_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386898.873729433864355, 5861811.579112778417766 ], [ 1386860.461439087055624, 5861779.947422447614372 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E79", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.20001220703125, "elevtn_dn": 745.29998779296875, "invlev_up": 752.70001220703125, "invlev_dn": 742.79998779296875, "manhole_up": "manhole_705_generated", "manhole_dn": "manhole_706_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386860.461439087055624, 5861779.947422447614372 ], [ 1386822.049148740014061, 5861748.315732115879655 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E80", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 745.29998779296875, "elevtn_dn": 745.29998779296875, "invlev_up": 742.79998779296875, "invlev_dn": 742.79998779296875, "manhole_up": "manhole_706_generated", "manhole_dn": "manhole_707_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386822.049148740014061, 5861748.315732115879655 ], [ 1386774.418702265014872, 5861733.958941764198244 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E81", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 745.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 742.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_707_generated", "manhole_dn": "manhole_708_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386774.418702265014872, 5861733.958941764198244 ], [ 1386726.75721522886306, 5861719.660321676172316 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E82", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_708_generated", "manhole_dn": "manhole_709_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386726.75721522886306, 5861719.660321676172316 ], [ 1386681.211287560872734, 5861700.510515534318984 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E83", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 777.9000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_709_generated", "manhole_dn": "manhole_710_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386681.211287560872734, 5861700.510515534318984 ], [ 1386655.081909105414525, 5861659.807657876051962 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E84", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 758.79998779296875, "invlev_up": 775.4000244140625, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_710_generated", "manhole_dn": "manhole_711_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386655.081909105414525, 5861659.807657876051962 ], [ 1386647.41175345890224, 5861610.757949161343277 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E85", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_711_generated", "manhole_dn": "manhole_712_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386647.41175345890224, 5861610.757949161343277 ], [ 1386641.745189253240824, 5861561.363539570011199 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E86", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 732.4000244140625, "invlev_up": 756.29998779296875, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_712_generated", "manhole_dn": "manhole_713_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386641.745189253240824, 5861561.363539570011199 ], [ 1386642.37134926696308, 5861511.607376066967845 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E87", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_713_generated", "manhole_dn": "manhole_714_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386642.37134926696308, 5861511.607376066967845 ], [ 1386642.997509280918166, 5861461.851212563924491 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E88", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_714_generated", "manhole_dn": "manhole_715_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386642.997509280918166, 5861461.851212563924491 ], [ 1386643.623669294640422, 5861412.09504906181246 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_34_E89", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 724.29998779296875, "invlev_up": 729.9000244140625, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_715_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386643.623669294640422, 5861412.09504906181246 ], [ 1386648.271799877518788, 5861347.644815167412162 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_35_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_35", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_35", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_716_generated", "manhole_dn": "manhole_717_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386060.978602184914052, 5859873.390328846871853 ], [ 1386078.54455375042744, 5859857.065600479952991 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_35_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_35", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_35", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_717_generated", "manhole_dn": "manhole_718_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386078.54455375042744, 5859857.065600479952991 ], [ 1386079.86695942771621, 5859885.500408614054322 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_36_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_36", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_36", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_719_generated", "manhole_dn": "manhole_716_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386030.926458492642269, 5859869.881591100245714 ], [ 1386060.978602184914052, 5859873.390328846871853 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_37_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_37", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_37", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_720_generated", "manhole_dn": "manhole_716_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386043.381105761509389, 5859908.11929196305573 ], [ 1386060.978602184914052, 5859873.390328846871853 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_38_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_38", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_718_generated", "manhole_dn": "manhole_721_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386079.86695942771621, 5859885.500408614054322 ], [ 1386081.40363402524963, 5859934.756705570034683 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_38_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_38", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_721_generated", "manhole_dn": "manhole_722_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386081.40363402524963, 5859934.756705570034683 ], [ 1386080.471781946951523, 5859983.948014200665057 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_38_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_38", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 756.5, "invlev_up": 763.79998779296875, "invlev_dn": 754.0, "manhole_up": "manhole_722_generated", "manhole_dn": "manhole_723_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386080.471781946951523, 5859983.948014200665057 ], [ 1386081.101269942475483, 5860033.01989212166518 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_39_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_39", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_718_generated", "manhole_dn": "manhole_724_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386079.86695942771621, 5859885.500408614054322 ], [ 1386051.415038994979113, 5859913.714703594334424 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_39_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_39", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_724_generated", "manhole_dn": "manhole_725_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386051.415038994979113, 5859913.714703594334424 ], [ 1386056.753747603856027, 5859949.43277302198112 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_39_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_39", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_725_generated", "manhole_dn": "manhole_726_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386056.753747603856027, 5859949.43277302198112 ], [ 1386070.153564189793542, 5859990.873222404159606 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_39_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_39", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 756.5, "invlev_up": 763.79998779296875, "invlev_dn": 754.0, "manhole_up": "manhole_726_generated", "manhole_dn": "manhole_723_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386070.153564189793542, 5859990.873222404159606 ], [ 1386081.101269942475483, 5860033.01989212166518 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.5, "elevtn_dn": 756.5, "invlev_up": 754.0, "invlev_dn": 754.0, "manhole_up": "manhole_723_generated", "manhole_dn": "manhole_727_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386081.101269942475483, 5860033.01989212166518 ], [ 1386095.159510504920036, 5860079.476792480796576 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.5, "elevtn_dn": 720.29998779296875, "invlev_up": 754.0, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_727_generated", "manhole_dn": "manhole_728_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386095.159510504920036, 5860079.476792480796576 ], [ 1386119.249574675457552, 5860122.285581497475505 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_728_generated", "manhole_dn": "manhole_729_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386119.249574675457552, 5860122.285581497475505 ], [ 1386143.813145637512207, 5860164.822058788500726 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 732.5, "invlev_up": 717.79998779296875, "invlev_dn": 730.0, "manhole_up": "manhole_729_generated", "manhole_dn": "manhole_730_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386143.813145637512207, 5860164.822058788500726 ], [ 1386168.698389830067754, 5860207.173543182201684 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.5, "elevtn_dn": 732.5, "invlev_up": 730.0, "invlev_dn": 730.0, "manhole_up": "manhole_730_generated", "manhole_dn": "manhole_731_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386168.698389830067754, 5860207.173543182201684 ], [ 1386190.960878706537187, 5860250.914158629253507 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.5, "elevtn_dn": 720.29998779296875, "invlev_up": 730.0, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_731_generated", "manhole_dn": "manhole_732_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386190.960878706537187, 5860250.914158629253507 ], [ 1386212.013376480899751, 5860295.295640649273992 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 729.10003662109375, "invlev_up": 717.79998779296875, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_732_generated", "manhole_dn": "manhole_733_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386212.013376480899751, 5860295.295640649273992 ], [ 1386233.065874255495146, 5860339.677122670225799 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 729.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_733_generated", "manhole_dn": "manhole_734_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386233.065874255495146, 5860339.677122670225799 ], [ 1386254.118372030090541, 5860384.058604690246284 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E8", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 729.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_734_generated", "manhole_dn": "manhole_735_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386254.118372030090541, 5860384.058604690246284 ], [ 1386270.265550139825791, 5860430.368606903590262 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E9", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 746.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 743.60003662109375, "manhole_up": "manhole_735_generated", "manhole_dn": "manhole_736_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386270.265550139825791, 5860430.368606903590262 ], [ 1386284.690116602927446, 5860477.310510716401041 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E10", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 746.10003662109375, "elevtn_dn": 746.10003662109375, "invlev_up": 743.60003662109375, "invlev_dn": 743.60003662109375, "manhole_up": "manhole_736_generated", "manhole_dn": "manhole_737_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386284.690116602927446, 5860477.310510716401041 ], [ 1386295.943752367515117, 5860525.125563691370189 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E11", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 746.10003662109375, "elevtn_dn": 720.29998779296875, "invlev_up": 743.60003662109375, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_737_generated", "manhole_dn": "manhole_738_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386295.943752367515117, 5860525.125563691370189 ], [ 1386307.197388132335618, 5860572.940616665408015 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E12", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_738_generated", "manhole_dn": "manhole_739_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386307.197388132335618, 5860572.940616665408015 ], [ 1386318.451023896923289, 5860620.755669640377164 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E13", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_739_generated", "manhole_dn": "manhole_740_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386318.451023896923289, 5860620.755669640377164 ], [ 1386329.704659661510959, 5860668.57072261441499 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E14", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 737.60003662109375, "invlev_up": 717.79998779296875, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_740_generated", "manhole_dn": "manhole_741_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386329.704659661510959, 5860668.57072261441499 ], [ 1386340.95829542633146, 5860716.385775589384139 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E15", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 737.60003662109375, "invlev_up": 735.10003662109375, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_741_generated", "manhole_dn": "manhole_742_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386340.95829542633146, 5860716.385775589384139 ], [ 1386352.211931190919131, 5860764.200828563421965 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E16", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 737.60003662109375, "invlev_up": 735.10003662109375, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_742_generated", "manhole_dn": "manhole_743_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386352.211931190919131, 5860764.200828563421965 ], [ 1386365.771370212780312, 5860811.365820310078561 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E17", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 744.5, "invlev_up": 735.10003662109375, "invlev_dn": 742.0, "manhole_up": "manhole_743_generated", "manhole_dn": "manhole_744_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386365.771370212780312, 5860811.365820310078561 ], [ 1386381.150273493025452, 5860858.017861452884972 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E18", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 744.5, "elevtn_dn": 724.29998779296875, "invlev_up": 742.0, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_744_generated", "manhole_dn": "manhole_745_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386381.150273493025452, 5860858.017861452884972 ], [ 1386398.399082327727228, 5860903.951519219204783 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E19", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_745_generated", "manhole_dn": "manhole_746_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386398.399082327727228, 5860903.951519219204783 ], [ 1386418.211523674428463, 5860948.90027645137161 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E20", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_746_generated", "manhole_dn": "manhole_747_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386418.211523674428463, 5860948.90027645137161 ], [ 1386441.67837643600069, 5860992.033180211670697 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E21", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_747_generated", "manhole_dn": "manhole_748_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386441.67837643600069, 5860992.033180211670697 ], [ 1386465.536530936835334, 5861034.971648660488427 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E22", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.9000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 722.4000244140625, "manhole_up": "manhole_748_generated", "manhole_dn": "manhole_749_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386465.536530936835334, 5861034.971648660488427 ], [ 1386489.394685437437147, 5861077.910117109306157 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E23", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.9000244140625, "elevtn_dn": 724.29998779296875, "invlev_up": 722.4000244140625, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_749_generated", "manhole_dn": "manhole_750_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386489.394685437437147, 5861077.910117109306157 ], [ 1386513.252839938271791, 5861120.848585557192564 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E24", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_750_generated", "manhole_dn": "manhole_751_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386513.252839938271791, 5861120.848585557192564 ], [ 1386537.110994438873604, 5861163.787054006010294 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E25", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_751_generated", "manhole_dn": "manhole_752_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386537.110994438873604, 5861163.787054006010294 ], [ 1386560.969148939708248, 5861206.725522454828024 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E26", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_752_generated", "manhole_dn": "manhole_753_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386560.969148939708248, 5861206.725522454828024 ], [ 1386584.827303440310061, 5861249.663990902714431 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E27", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_753_generated", "manhole_dn": "manhole_754_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386584.827303440310061, 5861249.663990902714431 ], [ 1386607.696082097478211, 5861293.105181481689215 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E28", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_754_generated", "manhole_dn": "manhole_755_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386607.696082097478211, 5861293.105181481689215 ], [ 1386626.999141034670174, 5861338.164890616200864 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E29", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 732.4000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_755_generated", "manhole_dn": "manhole_756_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386626.999141034670174, 5861338.164890616200864 ], [ 1386632.635544582502916, 5861386.242180755361915 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E30", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_756_generated", "manhole_dn": "manhole_757_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386632.635544582502916, 5861386.242180755361915 ], [ 1386628.332881111185998, 5861435.174896763637662 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E31", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_757_generated", "manhole_dn": "manhole_758_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386628.332881111185998, 5861435.174896763637662 ], [ 1386624.030217639869079, 5861484.107612771913409 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E32", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 758.79998779296875, "invlev_up": 729.9000244140625, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_758_generated", "manhole_dn": "manhole_759_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386624.030217639869079, 5861484.107612771913409 ], [ 1386619.72755416855216, 5861533.040328779257834 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E33", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_759_generated", "manhole_dn": "manhole_760_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386619.72755416855216, 5861533.040328779257834 ], [ 1386620.396809899713844, 5861581.843449912965298 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E34", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_760_generated", "manhole_dn": "manhole_761_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386620.396809899713844, 5861581.843449912965298 ], [ 1386627.242796876933426, 5861630.485572309233248 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E35", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 777.9000244140625, "invlev_up": 756.29998779296875, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_761_generated", "manhole_dn": "manhole_762_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386627.242796876933426, 5861630.485572309233248 ], [ 1386633.497009602142498, 5861679.177458625286818 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E36", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 777.9000244140625, "invlev_up": 775.4000244140625, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_762_generated", "manhole_dn": "manhole_763_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386633.497009602142498, 5861679.177458625286818 ], [ 1386633.587326586712152, 5861728.232037586160004 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E37", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 777.9000244140625, "invlev_up": 775.4000244140625, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_763_generated", "manhole_dn": "manhole_764_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386633.587326586712152, 5861728.232037586160004 ], [ 1386628.569951781770214, 5861777.096641942858696 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_40_E38", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 787.0, "invlev_up": 775.4000244140625, "invlev_dn": 784.5, "manhole_up": "manhole_764_generated", "manhole_dn": "manhole_765_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386628.569951781770214, 5861777.096641942858696 ], [ 1386623.552576976828277, 5861825.961246299557388 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 787.0, "elevtn_dn": 787.0, "invlev_up": 784.5, "invlev_dn": 784.5, "manhole_up": "manhole_765_generated", "manhole_dn": "manhole_766_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386623.552576976828277, 5861825.961246299557388 ], [ 1386622.452884682221338, 5861875.377415779046714 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 787.0, "elevtn_dn": 768.0, "invlev_up": 784.5, "invlev_dn": 765.5, "manhole_up": "manhole_766_generated", "manhole_dn": "manhole_767_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386622.452884682221338, 5861875.377415779046714 ], [ 1386630.050831846194342, 5861924.208797036670148 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_767_generated", "manhole_dn": "manhole_768_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386630.050831846194342, 5861924.208797036670148 ], [ 1386645.112437101313844, 5861971.295391816645861 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_768_generated", "manhole_dn": "manhole_769_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386645.112437101313844, 5861971.295391816645861 ], [ 1386663.826805545249954, 5862017.116109635680914 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 729.0, "invlev_up": 765.5, "invlev_dn": 726.5, "manhole_up": "manhole_769_generated", "manhole_dn": "manhole_770_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386663.826805545249954, 5862017.116109635680914 ], [ 1386682.541173989186063, 5862062.93682745564729 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 729.0, "invlev_up": 726.5, "invlev_dn": 726.5, "manhole_up": "manhole_770_generated", "manhole_dn": "manhole_771_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386682.541173989186063, 5862062.93682745564729 ], [ 1386700.357504795538262, 5862109.113540357910097 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 729.0, "invlev_up": 726.5, "invlev_dn": 726.5, "manhole_up": "manhole_771_generated", "manhole_dn": "manhole_772_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386700.357504795538262, 5862109.113540357910097 ], [ 1386718.120609947945923, 5862155.311352676711977 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 724.29998779296875, "invlev_up": 726.5, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_772_generated", "manhole_dn": "manhole_773_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386718.120609947945923, 5862155.311352676711977 ], [ 1386735.883715100120753, 5862201.509164996445179 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E8", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_773_generated", "manhole_dn": "manhole_774_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386735.883715100120753, 5862201.509164996445179 ], [ 1386757.522535112220794, 5862245.993861058726907 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E9", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_774_generated", "manhole_dn": "manhole_775_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386757.522535112220794, 5862245.993861058726907 ], [ 1386779.73098383564502, 5862290.226773838512599 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E10", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_775_generated", "manhole_dn": "manhole_776_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386779.73098383564502, 5862290.226773838512599 ], [ 1386802.545179207576439, 5862334.095372994430363 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E11", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_776_generated", "manhole_dn": "manhole_777_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386802.545179207576439, 5862334.095372994430363 ], [ 1386831.207993831252679, 5862374.446442689746618 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E12", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 737.70001220703125, "invlev_up": 721.79998779296875, "invlev_dn": 735.20001220703125, "manhole_up": "manhole_777_generated", "manhole_dn": "manhole_778_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386831.207993831252679, 5862374.446442689746618 ], [ 1386859.988485741894692, 5862414.708453865721822 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E13", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.70001220703125, "elevtn_dn": 737.70001220703125, "invlev_up": 735.20001220703125, "invlev_dn": 735.20001220703125, "manhole_up": "manhole_778_generated", "manhole_dn": "manhole_779_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386859.988485741894692, 5862414.708453865721822 ], [ 1386891.035651177866384, 5862453.255039785988629 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E14", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.70001220703125, "elevtn_dn": 743.9000244140625, "invlev_up": 735.20001220703125, "invlev_dn": 741.4000244140625, "manhole_up": "manhole_779_generated", "manhole_dn": "manhole_780_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386891.035651177866384, 5862453.255039785988629 ], [ 1386922.082816614070907, 5862491.801625707186759 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E15", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 743.9000244140625, "elevtn_dn": 756.0, "invlev_up": 741.4000244140625, "invlev_dn": 753.5, "manhole_up": "manhole_780_generated", "manhole_dn": "manhole_781_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386922.082816614070907, 5862491.801625707186759 ], [ 1386953.12998205027543, 5862530.348211627453566 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E16", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.0, "elevtn_dn": 756.0, "invlev_up": 753.5, "invlev_dn": 753.5, "manhole_up": "manhole_781_generated", "manhole_dn": "manhole_782_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386953.12998205027543, 5862530.348211627453566 ], [ 1386984.177147486479953, 5862568.894797547720373 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E17", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.0, "elevtn_dn": 761.4000244140625, "invlev_up": 753.5, "invlev_dn": 758.9000244140625, "manhole_up": "manhole_782_generated", "manhole_dn": "manhole_783_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386984.177147486479953, 5862568.894797547720373 ], [ 1387010.83190148579888, 5862610.297833287157118 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E18", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.4000244140625, "elevtn_dn": 761.4000244140625, "invlev_up": 758.9000244140625, "invlev_dn": 758.9000244140625, "manhole_up": "manhole_783_generated", "manhole_dn": "manhole_784_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387010.83190148579888, 5862610.297833287157118 ], [ 1387033.474099110113457, 5862654.310293504968286 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E19", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.4000244140625, "elevtn_dn": 770.5, "invlev_up": 758.9000244140625, "invlev_dn": 768.0, "manhole_up": "manhole_784_generated", "manhole_dn": "manhole_785_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387033.474099110113457, 5862654.310293504968286 ], [ 1387056.116296734428033, 5862698.322753723710775 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E20", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 770.5, "elevtn_dn": 765.29998779296875, "invlev_up": 768.0, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_785_generated", "manhole_dn": "manhole_786_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387056.116296734428033, 5862698.322753723710775 ], [ 1387078.75849435874261, 5862742.335213942453265 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E21", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 765.29998779296875, "invlev_up": 762.79998779296875, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_786_generated", "manhole_dn": "manhole_787_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387078.75849435874261, 5862742.335213942453265 ], [ 1387101.400691983057186, 5862786.347674161195755 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E22", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 765.29998779296875, "invlev_up": 762.79998779296875, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_787_generated", "manhole_dn": "manhole_788_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387101.400691983057186, 5862786.347674161195755 ], [ 1387124.783531384309754, 5862829.966971693560481 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E23", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 764.20001220703125, "invlev_up": 762.79998779296875, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_788_generated", "manhole_dn": "manhole_789_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387124.783531384309754, 5862829.966971693560481 ], [ 1387148.551342260092497, 5862873.381910757161677 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E24", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 764.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_789_generated", "manhole_dn": "manhole_790_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387148.551342260092497, 5862873.381910757161677 ], [ 1387176.029596295906231, 5862914.516764627769589 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E25", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 764.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_790_generated", "manhole_dn": "manhole_791_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387176.029596295906231, 5862914.516764627769589 ], [ 1387204.050833505578339, 5862955.315435893833637 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E26", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 769.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 766.70001220703125, "manhole_up": "manhole_791_generated", "manhole_dn": "manhole_792_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387204.050833505578339, 5862955.315435893833637 ], [ 1387233.152246462181211, 5862995.351338926702738 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E27", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 769.20001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 766.70001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_792_generated", "manhole_dn": "manhole_793_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387233.152246462181211, 5862995.351338926702738 ], [ 1387262.253659419016913, 5863035.387241959571838 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E28", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 770.20001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_793_generated", "manhole_dn": "manhole_794_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387262.253659419016913, 5863035.387241959571838 ], [ 1387289.177211825968698, 5863076.714860137552023 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E29", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 770.20001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_794_generated", "manhole_dn": "manhole_795_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387289.177211825968698, 5863076.714860137552023 ], [ 1387304.666786204557866, 5863123.392671256326139 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E30", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 762.0, "invlev_up": 770.20001220703125, "invlev_dn": 759.5, "manhole_up": "manhole_795_generated", "manhole_dn": "manhole_796_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387304.666786204557866, 5863123.392671256326139 ], [ 1387314.520281337434426, 5863171.895173518918455 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E31", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 777.10003662109375, "invlev_up": 759.5, "invlev_dn": 774.60003662109375, "manhole_up": "manhole_796_generated", "manhole_dn": "manhole_797_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387314.520281337434426, 5863171.895173518918455 ], [ 1387324.142220750683919, 5863220.446013364940882 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E32", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.10003662109375, "elevtn_dn": 780.4000244140625, "invlev_up": 774.60003662109375, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_797_generated", "manhole_dn": "manhole_798_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387324.142220750683919, 5863220.446013364940882 ], [ 1387333.764160163700581, 5863268.996853210031986 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E33", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 780.4000244140625, "invlev_up": 777.9000244140625, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_798_generated", "manhole_dn": "manhole_799_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387333.764160163700581, 5863268.996853210031986 ], [ 1387343.386099576717243, 5863317.547693055123091 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E34", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 780.4000244140625, "invlev_up": 777.9000244140625, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_799_generated", "manhole_dn": "manhole_800_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387343.386099576717243, 5863317.547693055123091 ], [ 1387353.008038989733905, 5863366.098532900214195 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E35", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 762.0, "invlev_up": 777.9000244140625, "invlev_dn": 759.5, "manhole_up": "manhole_800_generated", "manhole_dn": "manhole_801_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387353.008038989733905, 5863366.098532900214195 ], [ 1387364.066297837067395, 5863414.311534740030766 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E36", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_801_generated", "manhole_dn": "manhole_802_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387364.066297837067395, 5863414.311534740030766 ], [ 1387381.839409928303212, 5863460.427046488039196 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E37", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_802_generated", "manhole_dn": "manhole_803_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387381.839409928303212, 5863460.427046488039196 ], [ 1387403.429578960640356, 5863504.96100580971688 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E38", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_803_generated", "manhole_dn": "manhole_804_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387403.429578960640356, 5863504.96100580971688 ], [ 1387425.140452897874638, 5863549.440256260335445 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E39", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_804_generated", "manhole_dn": "manhole_805_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387425.140452897874638, 5863549.440256260335445 ], [ 1387446.851326835108921, 5863593.91950671095401 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E40", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_805_generated", "manhole_dn": "manhole_806_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387446.851326835108921, 5863593.91950671095401 ], [ 1387467.528695637593046, 5863638.888379830867052 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E41", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 774.5, "invlev_up": 759.5, "invlev_dn": 772.0, "manhole_up": "manhole_806_generated", "manhole_dn": "manhole_807_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387467.528695637593046, 5863638.888379830867052 ], [ 1387488.196078018052503, 5863683.861984014511108 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E42", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 774.5, "elevtn_dn": 762.0, "invlev_up": 772.0, "invlev_dn": 759.5, "manhole_up": "manhole_807_generated", "manhole_dn": "manhole_808_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387488.196078018052503, 5863683.861984014511108 ], [ 1387508.863468252588063, 5863728.835584589280188 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E43", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_808_generated", "manhole_dn": "manhole_809_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387508.863468252588063, 5863728.835584589280188 ], [ 1387529.53130904212594, 5863773.808978110551834 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E44", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_809_generated", "manhole_dn": "manhole_810_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387529.53130904212594, 5863773.808978110551834 ], [ 1387553.168002701364458, 5863817.17347530182451 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E45", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_810_generated", "manhole_dn": "manhole_811_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387553.168002701364458, 5863817.17347530182451 ], [ 1387579.562712850514799, 5863859.043333718553185 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E46", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 777.0, "invlev_up": 759.5, "invlev_dn": 774.5, "manhole_up": "manhole_811_generated", "manhole_dn": "manhole_812_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387579.562712850514799, 5863859.043333718553185 ], [ 1387605.957422999665141, 5863900.913192136213183 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E47", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.0, "elevtn_dn": 762.0, "invlev_up": 774.5, "invlev_dn": 759.5, "manhole_up": "manhole_812_generated", "manhole_dn": "manhole_813_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387605.957422999665141, 5863900.913192136213183 ], [ 1387632.352133149048313, 5863942.783050553873181 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E48", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_813_generated", "manhole_dn": "manhole_814_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387632.352133149048313, 5863942.783050553873181 ], [ 1387658.746843298198655, 5863984.652908970601857 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E49", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_814_generated", "manhole_dn": "manhole_815_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387658.746843298198655, 5863984.652908970601857 ], [ 1387685.893106181640178, 5864026.029537551105022 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E50", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_815_generated", "manhole_dn": "manhole_816_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387685.893106181640178, 5864026.029537551105022 ], [ 1387711.231136992340907, 5864068.42725711222738 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E51", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_816_generated", "manhole_dn": "manhole_817_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387711.231136992340907, 5864068.42725711222738 ], [ 1387731.020947323646396, 5864113.414904261007905 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E52", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_817_generated", "manhole_dn": "manhole_818_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387731.020947323646396, 5864113.414904261007905 ], [ 1387737.361907477490604, 5864162.342261835932732 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E53", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_818_generated", "manhole_dn": "manhole_819_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387737.361907477490604, 5864162.342261835932732 ], [ 1387732.727565656881779, 5864211.475179814733565 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E54", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_819_generated", "manhole_dn": "manhole_820_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387732.727565656881779, 5864211.475179814733565 ], [ 1387717.67884943424724, 5864258.627082298509777 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E55", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_820_generated", "manhole_dn": "manhole_821_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387717.67884943424724, 5864258.627082298509777 ], [ 1387709.67210421175696, 5864307.23127611912787 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E56", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 768.0, "invlev_up": 759.5, "invlev_dn": 765.5, "manhole_up": "manhole_821_generated", "manhole_dn": "manhole_822_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387709.67210421175696, 5864307.23127611912787 ], [ 1387707.11288084089756, 5864356.66017600055784 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E57", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_822_generated", "manhole_dn": "manhole_823_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387707.11288084089756, 5864356.66017600055784 ], [ 1387709.591797993984073, 5864406.012949175201356 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E58", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_823_generated", "manhole_dn": "manhole_824_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387709.591797993984073, 5864406.012949175201356 ], [ 1387713.643261310644448, 5864455.341961052268744 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E59", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 777.20001220703125, "invlev_up": 765.5, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_824_generated", "manhole_dn": "manhole_825_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387713.643261310644448, 5864455.341961052268744 ], [ 1387715.877521668095142, 5864504.642317942343652 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E60", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 774.70001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_825_generated", "manhole_dn": "manhole_826_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387715.877521668095142, 5864504.642317942343652 ], [ 1387708.68023270717822, 5864553.426558391191065 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E61", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 774.70001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_826_generated", "manhole_dn": "manhole_827_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387708.68023270717822, 5864553.426558391191065 ], [ 1387690.790250770282, 5864599.575386263430119 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E62", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 810.60003662109375, "invlev_up": 774.70001220703125, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_827_generated", "manhole_dn": "manhole_828_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387690.790250770282, 5864599.575386263430119 ], [ 1387672.900268833618611, 5864645.724214136600494 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E63", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 810.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_828_generated", "manhole_dn": "manhole_829_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387672.900268833618611, 5864645.724214136600494 ], [ 1387659.931900478899479, 5864692.98388583958149 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E64", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 810.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_829_generated", "manhole_dn": "manhole_830_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387659.931900478899479, 5864692.98388583958149 ], [ 1387659.223570322152227, 5864742.029465307481587 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E65", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_830_generated", "manhole_dn": "manhole_831_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387659.223570322152227, 5864742.029465307481587 ], [ 1387675.926896508783102, 5864788.273513910360634 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E66", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 774.10003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 771.60003662109375, "manhole_up": "manhole_831_generated", "manhole_dn": "manhole_832_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387675.926896508783102, 5864788.273513910360634 ], [ 1387702.296291569946334, 5864830.159320239908993 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E67", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 774.10003662109375, "elevtn_dn": 774.10003662109375, "invlev_up": 771.60003662109375, "invlev_dn": 771.60003662109375, "manhole_up": "manhole_832_generated", "manhole_dn": "manhole_833_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387702.296291569946334, 5864830.159320239908993 ], [ 1387728.665686630876735, 5864872.045126569457352 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E68", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 774.10003662109375, "elevtn_dn": 782.5, "invlev_up": 771.60003662109375, "invlev_dn": 780.0, "manhole_up": "manhole_833_generated", "manhole_dn": "manhole_834_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387728.665686630876735, 5864872.045126569457352 ], [ 1387751.608185108983889, 5864915.528788692317903 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E69", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 782.5, "invlev_up": 780.0, "invlev_dn": 780.0, "manhole_up": "manhole_834_generated", "manhole_dn": "manhole_835_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387751.608185108983889, 5864915.528788692317903 ], [ 1387766.741664502769709, 5864962.653554677963257 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E70", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 782.5, "invlev_up": 780.0, "invlev_dn": 780.0, "manhole_up": "manhole_835_generated", "manhole_dn": "manhole_836_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387766.741664502769709, 5864962.653554677963257 ], [ 1387778.99191950308159, 5865010.246724016033113 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E71", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 820.20001220703125, "invlev_up": 780.0, "invlev_dn": 817.70001220703125, "manhole_up": "manhole_836_generated", "manhole_dn": "manhole_837_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387778.99191950308159, 5865010.246724016033113 ], [ 1387779.554608268430457, 5865059.738633952103555 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E72", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 820.20001220703125, "elevtn_dn": 820.20001220703125, "invlev_up": 817.70001220703125, "invlev_dn": 817.70001220703125, "manhole_up": "manhole_837_generated", "manhole_dn": "manhole_838_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387779.554608268430457, 5865059.738633952103555 ], [ 1387780.117297033779323, 5865109.230543887242675 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E73", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 820.20001220703125, "elevtn_dn": 834.60003662109375, "invlev_up": 817.70001220703125, "invlev_dn": 832.10003662109375, "manhole_up": "manhole_838_generated", "manhole_dn": "manhole_839_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387780.117297033779323, 5865109.230543887242675 ], [ 1387782.917817069217563, 5865158.566991245374084 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E74", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 834.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 832.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_839_generated", "manhole_dn": "manhole_840_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387782.917817069217563, 5865158.566991245374084 ], [ 1387789.203931836877018, 5865207.661293652839959 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E75", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_840_generated", "manhole_dn": "manhole_841_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387789.203931836877018, 5865207.661293652839959 ], [ 1387795.490046604769304, 5865256.755596060305834 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E76", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_841_generated", "manhole_dn": "manhole_842_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387795.490046604769304, 5865256.755596060305834 ], [ 1387804.549934879876673, 5865305.332479531876743 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E77", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 809.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_842_generated", "manhole_dn": "manhole_843_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387804.549934879876673, 5865305.332479531876743 ], [ 1387816.386747075244784, 5865353.391356389038265 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E78", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 809.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_843_generated", "manhole_dn": "manhole_844_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387816.386747075244784, 5865353.391356389038265 ], [ 1387828.223559270845726, 5865401.450233246199787 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E79", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 802.5, "invlev_up": 809.10003662109375, "invlev_dn": 800.0, "manhole_up": "manhole_844_generated", "manhole_dn": "manhole_845_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387828.223559270845726, 5865401.450233246199787 ], [ 1387842.96627543354407, 5865448.679594250395894 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E80", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 802.5, "invlev_up": 800.0, "invlev_dn": 800.0, "manhole_up": "manhole_845_generated", "manhole_dn": "manhole_846_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387842.96627543354407, 5865448.679594250395894 ], [ 1387858.283513206522912, 5865495.744953005574644 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E81", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 802.5, "invlev_up": 800.0, "invlev_dn": 800.0, "manhole_up": "manhole_846_generated", "manhole_dn": "manhole_847_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387858.283513206522912, 5865495.744953005574644 ], [ 1387872.788357679266483, 5865543.026506381109357 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E82", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 778.20001220703125, "invlev_up": 800.0, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_847_generated", "manhole_dn": "manhole_848_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387872.788357679266483, 5865543.026506381109357 ], [ 1387882.890574953285977, 5865591.479689701460302 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E83", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_848_generated", "manhole_dn": "manhole_849_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387882.890574953285977, 5865591.479689701460302 ], [ 1387892.992792227305472, 5865639.932873022742569 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E84", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_849_generated", "manhole_dn": "manhole_850_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387892.992792227305472, 5865639.932873022742569 ], [ 1387903.095009501324967, 5865688.386056343093514 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_41_E85", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_850_generated", "manhole_dn": "manhole_851_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387903.095009501324967, 5865688.386056343093514 ], [ 1387913.197226775344461, 5865736.839239663444459 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_42_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 830.9000244140625, "invlev_up": 828.4000244140625, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_852_generated", "manhole_dn": "manhole_853_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387767.438602478476241, 5866395.894650792703032 ], [ 1387758.181959156645462, 5866444.388786932453513 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_42_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 830.9000244140625, "invlev_up": 828.4000244140625, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_853_generated", "manhole_dn": "manhole_854_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387758.181959156645462, 5866444.388786932453513 ], [ 1387748.925315835047513, 5866492.882923071272671 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_42_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 816.5, "invlev_up": 828.4000244140625, "invlev_dn": 814.0, "manhole_up": "manhole_854_generated", "manhole_dn": "manhole_855_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387748.925315835047513, 5866492.882923071272671 ], [ 1387739.668672513216734, 5866541.377059211023152 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_42_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.5, "elevtn_dn": 816.5, "invlev_up": 814.0, "invlev_dn": 814.0, "manhole_up": "manhole_855_generated", "manhole_dn": "manhole_856_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387739.668672513216734, 5866541.377059211023152 ], [ 1387730.412029191618785, 5866589.87119534984231 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_42_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.5, "elevtn_dn": 816.10003662109375, "invlev_up": 814.0, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_856_generated", "manhole_dn": "manhole_857_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387730.412029191618785, 5866589.87119534984231 ], [ 1387721.155385869788006, 5866638.365331489592791 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_42_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 816.10003662109375, "invlev_up": 813.60003662109375, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_857_generated", "manhole_dn": "manhole_858_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387721.155385869788006, 5866638.365331489592791 ], [ 1387711.868742506252602, 5866686.853722332976758 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_42_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 816.10003662109375, "invlev_up": 813.60003662109375, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_858_generated", "manhole_dn": "manhole_859_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387711.868742506252602, 5866686.853722332976758 ], [ 1387702.553355348296463, 5866735.336608462966979 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_42_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 802.4000244140625, "invlev_up": 813.60003662109375, "invlev_dn": 799.9000244140625, "manhole_up": "manhole_859_generated", "manhole_dn": "manhole_860_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387702.553355348296463, 5866735.336608462966979 ], [ 1387692.161796326050535, 5866783.420620376244187 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_43_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_43", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_43", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_861_generated", "manhole_dn": "manhole_862_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387809.534624515566975, 5866309.639251782558858 ], [ 1387788.486613497138023, 5866352.766951287165284 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_43_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_43", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_43", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 830.9000244140625, "invlev_up": 803.70001220703125, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_862_generated", "manhole_dn": "manhole_852_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387788.486613497138023, 5866352.766951287165284 ], [ 1387767.438602478476241, 5866395.894650792703032 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_44_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 840.10003662109375, "invlev_up": 828.4000244140625, "invlev_dn": 837.60003662109375, "manhole_up": "manhole_852_generated", "manhole_dn": "manhole_863_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387767.438602478476241, 5866395.894650792703032 ], [ 1387774.73306847945787, 5866351.644692087545991 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_44_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 840.10003662109375, "elevtn_dn": 806.20001220703125, "invlev_up": 837.60003662109375, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_863_generated", "manhole_dn": "manhole_864_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387774.73306847945787, 5866351.644692087545991 ], [ 1387787.219046234386042, 5866308.756401930935681 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_44_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_864_generated", "manhole_dn": "manhole_865_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387787.219046234386042, 5866308.756401930935681 ], [ 1387802.581935805035755, 5866266.622689731419086 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_44_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_865_generated", "manhole_dn": "manhole_866_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387802.581935805035755, 5866266.622689731419086 ], [ 1387818.989883717847988, 5866224.886323318816721 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_44_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_866_generated", "manhole_dn": "manhole_867_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387818.989883717847988, 5866224.886323318816721 ], [ 1387838.767447788733989, 5866184.784887914545834 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_44_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_867_generated", "manhole_dn": "manhole_868_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387838.767447788733989, 5866184.784887914545834 ], [ 1387862.375427621416748, 5866146.679679537191987 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_44_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 803.9000244140625, "invlev_up": 825.20001220703125, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_868_generated", "manhole_dn": "manhole_869_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387862.375427621416748, 5866146.679679537191987 ], [ 1387890.316308293025941, 5866111.904927220195532 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_44_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_869_generated", "manhole_dn": "manhole_870_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387890.316308293025941, 5866111.904927220195532 ], [ 1387932.086585889104754, 5866099.149365295656025 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_45_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_45", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_871_generated", "manhole_dn": "manhole_872_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387931.614702571649104, 5866170.542120457626879 ], [ 1387899.497387683717534, 5866203.806988564319909 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_45_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_45", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 806.20001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_872_generated", "manhole_dn": "manhole_873_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387899.497387683717534, 5866203.806988564319909 ], [ 1387869.509799961000681, 5866239.084409636445343 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_45_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_45", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_873_generated", "manhole_dn": "manhole_874_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387869.509799961000681, 5866239.084409636445343 ], [ 1387839.522212238283828, 5866274.361830709502101 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_45_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_45", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_874_generated", "manhole_dn": "manhole_861_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387839.522212238283828, 5866274.361830709502101 ], [ 1387809.534624515566975, 5866309.639251782558858 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_46_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_46", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_870_generated", "manhole_dn": "manhole_875_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387932.086585889104754, 5866099.149365295656025 ], [ 1387908.367353544337675, 5866141.903963415883482 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_46_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_46", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_875_generated", "manhole_dn": "manhole_876_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387908.367353544337675, 5866141.903963415883482 ], [ 1387876.955022902460769, 5866179.987773489207029 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_46_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_46", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 827.70001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_876_generated", "manhole_dn": "manhole_877_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387876.955022902460769, 5866179.987773489207029 ], [ 1387847.458594153402373, 5866219.470102892257273 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_46_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_46", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_877_generated", "manhole_dn": "manhole_878_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387847.458594153402373, 5866219.470102892257273 ], [ 1387823.639855962945148, 5866262.662997540086508 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_46_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_46", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_878_generated", "manhole_dn": "manhole_861_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387823.639855962945148, 5866262.662997540086508 ], [ 1387809.534624515566975, 5866309.639251782558858 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_47_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_47", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_879_generated", "manhole_dn": "manhole_880_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.443674022099003, 5865845.093254727311432 ], [ 1387943.318034203490242, 5865887.628139751963317 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_47_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_47", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_880_generated", "manhole_dn": "manhole_881_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387943.318034203490242, 5865887.628139751963317 ], [ 1387946.009428307646886, 5865930.175072746351361 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_47_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_47", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 816.70001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_881_generated", "manhole_dn": "manhole_882_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387946.009428307646886, 5865930.175072746351361 ], [ 1387948.700822412036359, 5865972.722005739808083 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_47_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_47", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_882_generated", "manhole_dn": "manhole_883_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387948.700822412036359, 5865972.722005739808083 ], [ 1387944.872250664513558, 5866015.105105520226061 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_47_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_47", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_883_generated", "manhole_dn": "manhole_884_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387944.872250664513558, 5866015.105105520226061 ], [ 1387940.047370131826028, 5866057.463170127011836 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_47_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_47", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 803.9000244140625, "invlev_up": 814.20001220703125, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_884_generated", "manhole_dn": "manhole_870_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.047370131826028, 5866057.463170127011836 ], [ 1387932.086585889104754, 5866099.149365295656025 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_48_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_48", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_48", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 786.29998779296875, "invlev_up": 801.4000244140625, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_870_generated", "manhole_dn": "manhole_885_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387932.086585889104754, 5866099.149365295656025 ], [ 1387975.279995472636074, 5866107.425722245126963 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E125", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 909.5, "elevtn_dn": 910.4000244140625, "invlev_up": 907.0, "invlev_dn": 907.9000244140625, "manhole_up": "manhole_886_generated", "manhole_dn": "manhole_887_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392926.966794768813998, 5866808.501405037939548 ], [ 1392879.417931769276038, 5866793.491589142940938 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E126", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 910.4000244140625, "elevtn_dn": 910.4000244140625, "invlev_up": 907.9000244140625, "invlev_dn": 907.9000244140625, "manhole_up": "manhole_887_generated", "manhole_dn": "manhole_888_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392879.417931769276038, 5866793.491589142940938 ], [ 1392831.869068769738078, 5866778.481773247942328 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E127", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 910.4000244140625, "elevtn_dn": 865.0, "invlev_up": 907.9000244140625, "invlev_dn": 862.5, "manhole_up": "manhole_888_generated", "manhole_dn": "manhole_889_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392831.869068769738078, 5866778.481773247942328 ], [ 1392784.320205770200118, 5866763.471957352943718 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E128", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 865.0, "elevtn_dn": 865.0, "invlev_up": 862.5, "invlev_dn": 862.5, "manhole_up": "manhole_889_generated", "manhole_dn": "manhole_890_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392784.320205770200118, 5866763.471957352943718 ], [ 1392736.771342770429328, 5866748.462141457945108 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E129", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 865.0, "elevtn_dn": 878.4000244140625, "invlev_up": 862.5, "invlev_dn": 875.9000244140625, "manhole_up": "manhole_890_generated", "manhole_dn": "manhole_891_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392736.771342770429328, 5866748.462141457945108 ], [ 1392689.222479770891368, 5866733.452325562946498 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E130", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 878.4000244140625, "elevtn_dn": 878.4000244140625, "invlev_up": 875.9000244140625, "invlev_dn": 875.9000244140625, "manhole_up": "manhole_891_generated", "manhole_dn": "manhole_892_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392689.222479770891368, 5866733.452325562946498 ], [ 1392641.673616771353409, 5866718.442509667947888 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E131", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 878.4000244140625, "elevtn_dn": 904.9000244140625, "invlev_up": 875.9000244140625, "invlev_dn": 902.4000244140625, "manhole_up": "manhole_892_generated", "manhole_dn": "manhole_893_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392641.673616771353409, 5866718.442509667947888 ], [ 1392594.124753771815449, 5866703.432693773880601 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E132", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 904.9000244140625, "elevtn_dn": 904.9000244140625, "invlev_up": 902.4000244140625, "invlev_dn": 902.4000244140625, "manhole_up": "manhole_893_generated", "manhole_dn": "manhole_894_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392594.124753771815449, 5866703.432693773880601 ], [ 1392546.575890772277489, 5866688.422877878881991 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E133", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 904.9000244140625, "elevtn_dn": 931.5, "invlev_up": 902.4000244140625, "invlev_dn": 929.0, "manhole_up": "manhole_894_generated", "manhole_dn": "manhole_895_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392546.575890772277489, 5866688.422877878881991 ], [ 1392499.02702777273953, 5866673.413061983883381 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E134", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 931.5, "elevtn_dn": 931.5, "invlev_up": 929.0, "invlev_dn": 929.0, "manhole_up": "manhole_895_generated", "manhole_dn": "manhole_896_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392499.02702777273953, 5866673.413061983883381 ], [ 1392451.47816477320157, 5866658.403246088884771 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E135", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 931.5, "elevtn_dn": 926.29998779296875, "invlev_up": 929.0, "invlev_dn": 923.79998779296875, "manhole_up": "manhole_896_generated", "manhole_dn": "manhole_897_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392451.47816477320157, 5866658.403246088884771 ], [ 1392403.92930177366361, 5866643.393430193886161 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E136", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 926.29998779296875, "elevtn_dn": 849.79998779296875, "invlev_up": 923.79998779296875, "invlev_dn": 847.29998779296875, "manhole_up": "manhole_897_generated", "manhole_dn": "manhole_898_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392403.92930177366361, 5866643.393430193886161 ], [ 1392356.380438774125651, 5866628.383614298887551 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E137", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 849.79998779296875, "elevtn_dn": 875.20001220703125, "invlev_up": 847.29998779296875, "invlev_dn": 872.70001220703125, "manhole_up": "manhole_898_generated", "manhole_dn": "manhole_899_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392356.380438774125651, 5866628.383614298887551 ], [ 1392308.831575774587691, 5866613.373798403888941 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E138", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 875.20001220703125, "elevtn_dn": 875.20001220703125, "invlev_up": 872.70001220703125, "invlev_dn": 872.70001220703125, "manhole_up": "manhole_899_generated", "manhole_dn": "manhole_900_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392308.831575774587691, 5866613.373798403888941 ], [ 1392261.282712775049731, 5866598.363982509821653 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E139", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 875.20001220703125, "elevtn_dn": 928.10003662109375, "invlev_up": 872.70001220703125, "invlev_dn": 925.60003662109375, "manhole_up": "manhole_900_generated", "manhole_dn": "manhole_901_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392261.282712775049731, 5866598.363982509821653 ], [ 1392213.733849775511771, 5866583.354166614823043 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E140", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 928.10003662109375, "elevtn_dn": 928.10003662109375, "invlev_up": 925.60003662109375, "invlev_dn": 925.60003662109375, "manhole_up": "manhole_901_generated", "manhole_dn": "manhole_902_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392213.733849775511771, 5866583.354166614823043 ], [ 1392166.184986775973812, 5866568.344350719824433 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E141", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 928.10003662109375, "elevtn_dn": 936.79998779296875, "invlev_up": 925.60003662109375, "invlev_dn": 934.29998779296875, "manhole_up": "manhole_902_generated", "manhole_dn": "manhole_903_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392166.184986775973812, 5866568.344350719824433 ], [ 1392119.234377897810191, 5866551.59017149079591 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E142", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 936.79998779296875, "elevtn_dn": 936.79998779296875, "invlev_up": 934.29998779296875, "invlev_dn": 934.29998779296875, "manhole_up": "manhole_903_generated", "manhole_dn": "manhole_904_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392119.234377897810191, 5866551.59017149079591 ], [ 1392072.481987217208371, 5866534.25803626794368 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E143", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 936.79998779296875, "elevtn_dn": 929.79998779296875, "invlev_up": 934.29998779296875, "invlev_dn": 927.29998779296875, "manhole_up": "manhole_904_generated", "manhole_dn": "manhole_905_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392072.481987217208371, 5866534.25803626794368 ], [ 1392025.729596536839381, 5866516.925901044160128 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E144", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 929.79998779296875, "elevtn_dn": 892.29998779296875, "invlev_up": 927.29998779296875, "invlev_dn": 889.79998779296875, "manhole_up": "manhole_905_generated", "manhole_dn": "manhole_906_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392025.729596536839381, 5866516.925901044160128 ], [ 1391978.977205856470391, 5866499.593765820376575 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E145", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 892.29998779296875, "elevtn_dn": 911.4000244140625, "invlev_up": 889.79998779296875, "invlev_dn": 908.9000244140625, "manhole_up": "manhole_906_generated", "manhole_dn": "manhole_907_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391978.977205856470391, 5866499.593765820376575 ], [ 1391932.224815175868571, 5866482.261630596593022 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E146", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 911.4000244140625, "elevtn_dn": 911.4000244140625, "invlev_up": 908.9000244140625, "invlev_dn": 908.9000244140625, "manhole_up": "manhole_907_generated", "manhole_dn": "manhole_908_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391932.224815175868571, 5866482.261630596593022 ], [ 1391885.472424495499581, 5866464.92949537280947 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E147", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 911.4000244140625, "elevtn_dn": 933.20001220703125, "invlev_up": 908.9000244140625, "invlev_dn": 930.70001220703125, "manhole_up": "manhole_908_generated", "manhole_dn": "manhole_909_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391885.472424495499581, 5866464.92949537280947 ], [ 1391838.720033814897761, 5866447.59736014995724 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E148", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 933.20001220703125, "elevtn_dn": 933.20001220703125, "invlev_up": 930.70001220703125, "invlev_dn": 930.70001220703125, "manhole_up": "manhole_909_generated", "manhole_dn": "manhole_910_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391838.720033814897761, 5866447.59736014995724 ], [ 1391791.967643134528771, 5866430.265224926173687 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E149", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 933.20001220703125, "elevtn_dn": 939.4000244140625, "invlev_up": 930.70001220703125, "invlev_dn": 936.9000244140625, "manhole_up": "manhole_910_generated", "manhole_dn": "manhole_911_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391791.967643134528771, 5866430.265224926173687 ], [ 1391745.215252453926951, 5866412.933089702390134 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E150", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 939.4000244140625, "elevtn_dn": 939.4000244140625, "invlev_up": 936.9000244140625, "invlev_dn": 936.9000244140625, "manhole_up": "manhole_911_generated", "manhole_dn": "manhole_912_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391745.215252453926951, 5866412.933089702390134 ], [ 1391698.462861773557961, 5866395.600954478606582 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E151", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 939.4000244140625, "elevtn_dn": 952.70001220703125, "invlev_up": 936.9000244140625, "invlev_dn": 950.20001220703125, "manhole_up": "manhole_912_generated", "manhole_dn": "manhole_913_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391698.462861773557961, 5866395.600954478606582 ], [ 1391651.710471092956141, 5866378.268819254823029 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E152", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.70001220703125, "elevtn_dn": 889.4000244140625, "invlev_up": 950.20001220703125, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_913_generated", "manhole_dn": "manhole_914_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391651.710471092956141, 5866378.268819254823029 ], [ 1391604.958080412587151, 5866360.936684031039476 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E153", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 848.70001220703125, "invlev_up": 886.9000244140625, "invlev_dn": 846.20001220703125, "manhole_up": "manhole_914_generated", "manhole_dn": "manhole_915_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391604.958080412587151, 5866360.936684031039476 ], [ 1391558.205689732218161, 5866343.604548808187246 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E154", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 848.70001220703125, "elevtn_dn": 848.70001220703125, "invlev_up": 846.20001220703125, "invlev_dn": 846.20001220703125, "manhole_up": "manhole_915_generated", "manhole_dn": "manhole_916_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391558.205689732218161, 5866343.604548808187246 ], [ 1391511.453299051616341, 5866326.272413584403694 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E155", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 848.70001220703125, "elevtn_dn": 846.0, "invlev_up": 846.20001220703125, "invlev_dn": 843.5, "manhole_up": "manhole_916_generated", "manhole_dn": "manhole_917_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391511.453299051616341, 5866326.272413584403694 ], [ 1391464.700908371247351, 5866308.940278360620141 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E156", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 846.0, "elevtn_dn": 846.0, "invlev_up": 843.5, "invlev_dn": 843.5, "manhole_up": "manhole_917_generated", "manhole_dn": "manhole_918_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391464.700908371247351, 5866308.940278360620141 ], [ 1391417.948517690645531, 5866291.608143136836588 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E157", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 846.0, "elevtn_dn": 849.9000244140625, "invlev_up": 843.5, "invlev_dn": 847.4000244140625, "manhole_up": "manhole_918_generated", "manhole_dn": "manhole_919_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391417.948517690645531, 5866291.608143136836588 ], [ 1391371.196127010276541, 5866274.276007913053036 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E158", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 849.9000244140625, "elevtn_dn": 849.9000244140625, "invlev_up": 847.4000244140625, "invlev_dn": 847.4000244140625, "manhole_up": "manhole_919_generated", "manhole_dn": "manhole_920_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391371.196127010276541, 5866274.276007913053036 ], [ 1391321.986832652939484, 5866269.550851707346737 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E159", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 849.9000244140625, "elevtn_dn": 895.70001220703125, "invlev_up": 847.4000244140625, "invlev_dn": 893.20001220703125, "manhole_up": "manhole_920_generated", "manhole_dn": "manhole_921_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391321.986832652939484, 5866269.550851707346737 ], [ 1391272.147464629728347, 5866268.058758955448866 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E160", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 895.70001220703125, "elevtn_dn": 895.70001220703125, "invlev_up": 893.20001220703125, "invlev_dn": 893.20001220703125, "manhole_up": "manhole_921_generated", "manhole_dn": "manhole_922_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391272.147464629728347, 5866268.058758955448866 ], [ 1391222.30809660628438, 5866266.566666204482317 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E161", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 895.70001220703125, "elevtn_dn": 932.0, "invlev_up": 893.20001220703125, "invlev_dn": 929.5, "manhole_up": "manhole_922_generated", "manhole_dn": "manhole_923_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391222.30809660628438, 5866266.566666204482317 ], [ 1391172.468728582840413, 5866265.074573452584445 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E162", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 932.0, "invlev_up": 929.5, "invlev_dn": 929.5, "manhole_up": "manhole_923_generated", "manhole_dn": "manhole_924_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391172.468728582840413, 5866265.074573452584445 ], [ 1391122.629360559629276, 5866263.582480700686574 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E163", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 915.20001220703125, "invlev_up": 929.5, "invlev_dn": 912.70001220703125, "manhole_up": "manhole_924_generated", "manhole_dn": "manhole_925_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391122.629360559629276, 5866263.582480700686574 ], [ 1391072.789992536185309, 5866262.090387949720025 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E164", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.20001220703125, "elevtn_dn": 880.70001220703125, "invlev_up": 912.70001220703125, "invlev_dn": 878.20001220703125, "manhole_up": "manhole_925_generated", "manhole_dn": "manhole_926_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391072.789992536185309, 5866262.090387949720025 ], [ 1391022.950624512741342, 5866260.598295197822154 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E165", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 880.70001220703125, "elevtn_dn": 880.70001220703125, "invlev_up": 878.20001220703125, "invlev_dn": 878.20001220703125, "manhole_up": "manhole_926_generated", "manhole_dn": "manhole_927_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391022.950624512741342, 5866260.598295197822154 ], [ 1390973.111256489530206, 5866259.106202445924282 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E166", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 880.70001220703125, "elevtn_dn": 889.4000244140625, "invlev_up": 878.20001220703125, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_927_generated", "manhole_dn": "manhole_928_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390973.111256489530206, 5866259.106202445924282 ], [ 1390923.271888466086239, 5866257.614109694957733 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E167", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 889.4000244140625, "invlev_up": 886.9000244140625, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_928_generated", "manhole_dn": "manhole_929_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390923.271888466086239, 5866257.614109694957733 ], [ 1390873.432520442642272, 5866256.122016943059862 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E168", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 935.79998779296875, "invlev_up": 886.9000244140625, "invlev_dn": 933.29998779296875, "manhole_up": "manhole_929_generated", "manhole_dn": "manhole_930_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390873.432520442642272, 5866256.122016943059862 ], [ 1390823.593152419198304, 5866254.62992419116199 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E169", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.79998779296875, "elevtn_dn": 935.79998779296875, "invlev_up": 933.29998779296875, "invlev_dn": 933.29998779296875, "manhole_up": "manhole_930_generated", "manhole_dn": "manhole_931_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390823.593152419198304, 5866254.62992419116199 ], [ 1390773.753784395987168, 5866253.137831440195441 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E170", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.79998779296875, "elevtn_dn": 957.79998779296875, "invlev_up": 933.29998779296875, "invlev_dn": 955.29998779296875, "manhole_up": "manhole_931_generated", "manhole_dn": "manhole_932_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390773.753784395987168, 5866253.137831440195441 ], [ 1390723.914416372543201, 5866251.64573868829757 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E171", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.79998779296875, "elevtn_dn": 957.79998779296875, "invlev_up": 955.29998779296875, "invlev_dn": 955.29998779296875, "manhole_up": "manhole_932_generated", "manhole_dn": "manhole_933_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390723.914416372543201, 5866251.64573868829757 ], [ 1390674.075048349099234, 5866250.153645936399698 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E172", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.79998779296875, "elevtn_dn": 957.0, "invlev_up": 955.29998779296875, "invlev_dn": 954.5, "manhole_up": "manhole_933_generated", "manhole_dn": "manhole_934_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390674.075048349099234, 5866250.153645936399698 ], [ 1390624.235680325888097, 5866248.661553185433149 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E173", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.0, "elevtn_dn": 957.0, "invlev_up": 954.5, "invlev_dn": 954.5, "manhole_up": "manhole_934_generated", "manhole_dn": "manhole_935_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390624.235680325888097, 5866248.661553185433149 ], [ 1390574.39631230244413, 5866247.169460433535278 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E174", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.0, "elevtn_dn": 964.5, "invlev_up": 954.5, "invlev_dn": 962.0, "manhole_up": "manhole_935_generated", "manhole_dn": "manhole_936_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390574.39631230244413, 5866247.169460433535278 ], [ 1390524.556944279000163, 5866245.677367681637406 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E175", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 964.5, "invlev_up": 962.0, "invlev_dn": 962.0, "manhole_up": "manhole_936_generated", "manhole_dn": "manhole_937_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390524.556944279000163, 5866245.677367681637406 ], [ 1390474.717576255789027, 5866244.185274930670857 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E176", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 948.5, "invlev_up": 962.0, "invlev_dn": 946.0, "manhole_up": "manhole_937_generated", "manhole_dn": "manhole_938_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390474.717576255789027, 5866244.185274930670857 ], [ 1390424.87820823234506, 5866242.693182178772986 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E177", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 948.5, "elevtn_dn": 970.10003662109375, "invlev_up": 946.0, "invlev_dn": 967.60003662109375, "manhole_up": "manhole_938_generated", "manhole_dn": "manhole_939_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390424.87820823234506, 5866242.693182178772986 ], [ 1390375.038840208901092, 5866241.201089426875114 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E178", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 970.10003662109375, "elevtn_dn": 970.10003662109375, "invlev_up": 967.60003662109375, "invlev_dn": 967.60003662109375, "manhole_up": "manhole_939_generated", "manhole_dn": "manhole_940_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390375.038840208901092, 5866241.201089426875114 ], [ 1390325.199472185689956, 5866239.708996675908566 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E179", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 970.10003662109375, "elevtn_dn": 975.4000244140625, "invlev_up": 967.60003662109375, "invlev_dn": 972.9000244140625, "manhole_up": "manhole_940_generated", "manhole_dn": "manhole_941_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390325.199472185689956, 5866239.708996675908566 ], [ 1390275.360104162245989, 5866238.216903924010694 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E180", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 975.4000244140625, "elevtn_dn": 975.4000244140625, "invlev_up": 972.9000244140625, "invlev_dn": 972.9000244140625, "manhole_up": "manhole_941_generated", "manhole_dn": "manhole_942_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390275.360104162245989, 5866238.216903924010694 ], [ 1390225.520736138802022, 5866236.724811173044145 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E181", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 975.4000244140625, "elevtn_dn": 1034.5, "invlev_up": 972.9000244140625, "invlev_dn": 1032.0, "manhole_up": "manhole_942_generated", "manhole_dn": "manhole_943_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390225.520736138802022, 5866236.724811173044145 ], [ 1390175.681368115358055, 5866235.232718421146274 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E182", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1034.5, "elevtn_dn": 1034.5, "invlev_up": 1032.0, "invlev_dn": 1032.0, "manhole_up": "manhole_943_generated", "manhole_dn": "manhole_944_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390175.681368115358055, 5866235.232718421146274 ], [ 1390125.842000092146918, 5866233.740625669248402 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E183", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1034.5, "elevtn_dn": 1053.9000244140625, "invlev_up": 1032.0, "invlev_dn": 1051.4000244140625, "manhole_up": "manhole_944_generated", "manhole_dn": "manhole_945_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390125.842000092146918, 5866233.740625669248402 ], [ 1390076.002632068702951, 5866232.248532918281853 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E184", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1053.9000244140625, "elevtn_dn": 956.9000244140625, "invlev_up": 1051.4000244140625, "invlev_dn": 954.4000244140625, "manhole_up": "manhole_945_generated", "manhole_dn": "manhole_946_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390076.002632068702951, 5866232.248532918281853 ], [ 1390026.163264045258984, 5866230.756440166383982 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E185", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 956.9000244140625, "elevtn_dn": 988.79998779296875, "invlev_up": 954.4000244140625, "invlev_dn": 986.29998779296875, "manhole_up": "manhole_946_generated", "manhole_dn": "manhole_947_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390026.163264045258984, 5866230.756440166383982 ], [ 1389976.323896022047848, 5866229.26434741448611 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E186", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 988.79998779296875, "elevtn_dn": 988.79998779296875, "invlev_up": 986.29998779296875, "invlev_dn": 986.29998779296875, "manhole_up": "manhole_947_generated", "manhole_dn": "manhole_948_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389976.323896022047848, 5866229.26434741448611 ], [ 1389926.48452799860388, 5866227.772254663519561 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E187", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 988.79998779296875, "elevtn_dn": 1051.0999755859375, "invlev_up": 986.29998779296875, "invlev_dn": 1048.5999755859375, "manhole_up": "manhole_948_generated", "manhole_dn": "manhole_949_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389926.48452799860388, 5866227.772254663519561 ], [ 1389876.645159975159913, 5866226.28016191162169 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E188", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1051.0999755859375, "elevtn_dn": 1051.0999755859375, "invlev_up": 1048.5999755859375, "invlev_dn": 1048.5999755859375, "manhole_up": "manhole_949_generated", "manhole_dn": "manhole_950_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389876.645159975159913, 5866226.28016191162169 ], [ 1389826.805791951948777, 5866224.788069159723818 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E189", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1051.0999755859375, "elevtn_dn": 1066.9000244140625, "invlev_up": 1048.5999755859375, "invlev_dn": 1064.4000244140625, "manhole_up": "manhole_950_generated", "manhole_dn": "manhole_951_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389826.805791951948777, 5866224.788069159723818 ], [ 1389776.96642392850481, 5866223.295976408757269 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E190", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1066.9000244140625, "elevtn_dn": 1031.2000732421875, "invlev_up": 1064.4000244140625, "invlev_dn": 1028.7000732421875, "manhole_up": "manhole_951_generated", "manhole_dn": "manhole_952_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389776.96642392850481, 5866223.295976408757269 ], [ 1389727.141182830790058, 5866221.468200048431754 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E191", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1031.2000732421875, "elevtn_dn": 1031.2000732421875, "invlev_up": 1028.7000732421875, "invlev_dn": 1028.7000732421875, "manhole_up": "manhole_952_generated", "manhole_dn": "manhole_953_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389727.141182830790058, 5866221.468200048431754 ], [ 1389677.352675863076001, 5866218.767548334784806 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E192", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1031.2000732421875, "elevtn_dn": 986.60003662109375, "invlev_up": 1028.7000732421875, "invlev_dn": 984.10003662109375, "manhole_up": "manhole_953_generated", "manhole_dn": "manhole_954_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389677.352675863076001, 5866218.767548334784806 ], [ 1389627.564168895594776, 5866216.066896621137857 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E193", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 986.60003662109375, "elevtn_dn": 986.60003662109375, "invlev_up": 984.10003662109375, "invlev_dn": 984.10003662109375, "manhole_up": "manhole_954_generated", "manhole_dn": "manhole_955_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389627.564168895594776, 5866216.066896621137857 ], [ 1389577.775661927880719, 5866213.366244907490909 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E194", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 986.60003662109375, "elevtn_dn": 964.70001220703125, "invlev_up": 984.10003662109375, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_955_generated", "manhole_dn": "manhole_956_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389577.775661927880719, 5866213.366244907490909 ], [ 1389527.987154960166663, 5866210.665593194775283 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E195", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 964.70001220703125, "invlev_up": 962.20001220703125, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_956_generated", "manhole_dn": "manhole_957_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389527.987154960166663, 5866210.665593194775283 ], [ 1389478.198647992452607, 5866207.964941481128335 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E196", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 996.29998779296875, "invlev_up": 962.20001220703125, "invlev_dn": 993.79998779296875, "manhole_up": "manhole_957_generated", "manhole_dn": "manhole_958_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389478.198647992452607, 5866207.964941481128335 ], [ 1389428.41014102473855, 5866205.264289767481387 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E197", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 996.29998779296875, "elevtn_dn": 996.29998779296875, "invlev_up": 993.79998779296875, "invlev_dn": 993.79998779296875, "manhole_up": "manhole_958_generated", "manhole_dn": "manhole_959_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389428.41014102473855, 5866205.264289767481387 ], [ 1389378.621634057024494, 5866202.563638053834438 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E198", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 996.29998779296875, "elevtn_dn": 1030.4000244140625, "invlev_up": 993.79998779296875, "invlev_dn": 1027.9000244140625, "manhole_up": "manhole_959_generated", "manhole_dn": "manhole_960_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389378.621634057024494, 5866202.563638053834438 ], [ 1389328.833127089310437, 5866199.86298634018749 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E199", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1030.4000244140625, "elevtn_dn": 1030.4000244140625, "invlev_up": 1027.9000244140625, "invlev_dn": 1027.9000244140625, "manhole_up": "manhole_960_generated", "manhole_dn": "manhole_961_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389328.833127089310437, 5866199.86298634018749 ], [ 1389279.044620121829212, 5866197.162334626540542 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E200", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1030.4000244140625, "elevtn_dn": 1053.800048828125, "invlev_up": 1027.9000244140625, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_961_generated", "manhole_dn": "manhole_962_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389279.044620121829212, 5866197.162334626540542 ], [ 1389229.256113154115155, 5866194.461682912893593 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E201", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1053.800048828125, "invlev_up": 1051.300048828125, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_962_generated", "manhole_dn": "manhole_963_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389229.256113154115155, 5866194.461682912893593 ], [ 1389179.467606186401099, 5866191.761031199246645 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E202", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1067.5999755859375, "invlev_up": 1051.300048828125, "invlev_dn": 1065.0999755859375, "manhole_up": "manhole_963_generated", "manhole_dn": "manhole_964_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389179.467606186401099, 5866191.761031199246645 ], [ 1389129.679099218687043, 5866189.060379485599697 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E203", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1067.5999755859375, "elevtn_dn": 1070.7000732421875, "invlev_up": 1065.0999755859375, "invlev_dn": 1068.2000732421875, "manhole_up": "manhole_964_generated", "manhole_dn": "manhole_965_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389129.679099218687043, 5866189.060379485599697 ], [ 1389079.890592250972986, 5866186.359727771952748 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E204", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1070.7000732421875, "elevtn_dn": 1070.7000732421875, "invlev_up": 1068.2000732421875, "invlev_dn": 1068.2000732421875, "manhole_up": "manhole_965_generated", "manhole_dn": "manhole_966_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389079.890592250972986, 5866186.359727771952748 ], [ 1389030.10208528325893, 5866183.6590760583058 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E205", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1070.7000732421875, "elevtn_dn": 1075.0, "invlev_up": 1068.2000732421875, "invlev_dn": 1072.5, "manhole_up": "manhole_966_generated", "manhole_dn": "manhole_967_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389030.10208528325893, 5866183.6590760583058 ], [ 1388980.313578315777704, 5866180.958424345590174 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E206", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1075.0, "elevtn_dn": 1075.0, "invlev_up": 1072.5, "invlev_dn": 1072.5, "manhole_up": "manhole_967_generated", "manhole_dn": "manhole_968_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388980.313578315777704, 5866180.958424345590174 ], [ 1388930.525071348063648, 5866178.257772631943226 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E207", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1075.0, "elevtn_dn": 1074.0999755859375, "invlev_up": 1072.5, "invlev_dn": 1071.5999755859375, "manhole_up": "manhole_968_generated", "manhole_dn": "manhole_969_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388930.525071348063648, 5866178.257772631943226 ], [ 1388880.736564380349591, 5866175.557120918296278 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E208", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1074.0999755859375, "elevtn_dn": 1074.0999755859375, "invlev_up": 1071.5999755859375, "invlev_dn": 1071.5999755859375, "manhole_up": "manhole_969_generated", "manhole_dn": "manhole_970_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388880.736564380349591, 5866175.557120918296278 ], [ 1388830.948057412635535, 5866172.856469204649329 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E209", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1074.0999755859375, "elevtn_dn": 1053.800048828125, "invlev_up": 1071.5999755859375, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_970_generated", "manhole_dn": "manhole_971_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388830.948057412635535, 5866172.856469204649329 ], [ 1388781.159550444921479, 5866170.155817491002381 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E210", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1053.800048828125, "invlev_up": 1051.300048828125, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_971_generated", "manhole_dn": "manhole_972_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388781.159550444921479, 5866170.155817491002381 ], [ 1388731.371043477207422, 5866167.455165777355433 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E211", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1017.0, "invlev_up": 1051.300048828125, "invlev_dn": 1014.5, "manhole_up": "manhole_972_generated", "manhole_dn": "manhole_973_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388731.371043477207422, 5866167.455165777355433 ], [ 1388681.582536509493366, 5866164.754514063708484 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E212", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1017.0, "elevtn_dn": 1017.0, "invlev_up": 1014.5, "invlev_dn": 1014.5, "manhole_up": "manhole_973_generated", "manhole_dn": "manhole_974_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388681.582536509493366, 5866164.754514063708484 ], [ 1388631.79402954201214, 5866162.053862350061536 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E213", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1017.0, "elevtn_dn": 973.20001220703125, "invlev_up": 1014.5, "invlev_dn": 970.70001220703125, "manhole_up": "manhole_974_generated", "manhole_dn": "manhole_975_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388631.79402954201214, 5866162.053862350061536 ], [ 1388582.005522574298084, 5866159.353210636414587 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E214", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 973.20001220703125, "elevtn_dn": 973.20001220703125, "invlev_up": 970.70001220703125, "invlev_dn": 970.70001220703125, "manhole_up": "manhole_975_generated", "manhole_dn": "manhole_976_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388582.005522574298084, 5866159.353210636414587 ], [ 1388532.217015606584027, 5866156.652558922767639 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E215", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 973.20001220703125, "elevtn_dn": 935.20001220703125, "invlev_up": 970.70001220703125, "invlev_dn": 932.70001220703125, "manhole_up": "manhole_976_generated", "manhole_dn": "manhole_977_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388532.217015606584027, 5866156.652558922767639 ], [ 1388482.428508638869971, 5866153.951907209120691 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E216", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.20001220703125, "elevtn_dn": 935.20001220703125, "invlev_up": 932.70001220703125, "invlev_dn": 932.70001220703125, "manhole_up": "manhole_977_generated", "manhole_dn": "manhole_978_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388482.428508638869971, 5866153.951907209120691 ], [ 1388432.640001671155915, 5866151.251255496405065 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E217", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.20001220703125, "elevtn_dn": 895.79998779296875, "invlev_up": 932.70001220703125, "invlev_dn": 893.29998779296875, "manhole_up": "manhole_978_generated", "manhole_dn": "manhole_979_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388432.640001671155915, 5866151.251255496405065 ], [ 1388382.851494703441858, 5866148.550603782758117 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E218", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 895.79998779296875, "elevtn_dn": 852.60003662109375, "invlev_up": 893.29998779296875, "invlev_dn": 850.10003662109375, "manhole_up": "manhole_979_generated", "manhole_dn": "manhole_980_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388382.851494703441858, 5866148.550603782758117 ], [ 1388333.062987735960633, 5866145.849952069111168 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E219", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 852.60003662109375, "elevtn_dn": 852.60003662109375, "invlev_up": 850.10003662109375, "invlev_dn": 850.10003662109375, "manhole_up": "manhole_980_generated", "manhole_dn": "manhole_981_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388333.062987735960633, 5866145.849952069111168 ], [ 1388283.274480768246576, 5866143.14930035546422 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E220", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 852.60003662109375, "elevtn_dn": 818.4000244140625, "invlev_up": 850.10003662109375, "invlev_dn": 815.9000244140625, "manhole_up": "manhole_981_generated", "manhole_dn": "manhole_982_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388283.274480768246576, 5866143.14930035546422 ], [ 1388233.48597380053252, 5866140.448648641817272 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_49_E221", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 818.4000244140625, "elevtn_dn": 818.4000244140625, "invlev_up": 815.9000244140625, "invlev_dn": 815.9000244140625, "manhole_up": "manhole_982_generated", "manhole_dn": "manhole_983_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388233.48597380053252, 5866140.448648641817272 ], [ 1388183.697466832818463, 5866137.747996928170323 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_50_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 792.20001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_851_generated", "manhole_dn": "manhole_984_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387913.197226775344461, 5865736.839239663444459 ], [ 1387925.20445894007571, 5865784.545682998374104 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_50_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 804.4000244140625, "invlev_up": 792.20001220703125, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_984_generated", "manhole_dn": "manhole_985_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387925.20445894007571, 5865784.545682998374104 ], [ 1387937.21169110503979, 5865832.252126332372427 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_50_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_985_generated", "manhole_dn": "manhole_986_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387937.21169110503979, 5865832.252126332372427 ], [ 1387954.8270876808092, 5865878.043407939374447 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_50_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_986_generated", "manhole_dn": "manhole_987_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387954.8270876808092, 5865878.043407939374447 ], [ 1387967.620662312954664, 5865925.436966767534614 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_50_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 778.20001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_987_generated", "manhole_dn": "manhole_988_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387967.620662312954664, 5865925.436966767534614 ], [ 1387969.561903131194413, 5865974.386314341798425 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_50_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_988_generated", "manhole_dn": "manhole_989_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.561903131194413, 5865974.386314341798425 ], [ 1387968.98255812516436, 5866023.571071763522923 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_50_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_989_generated", "manhole_dn": "manhole_990_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387968.98255812516436, 5866023.571071763522923 ], [ 1387969.225197304505855, 5866072.657253311946988 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_50_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 786.29998779296875, "invlev_up": 775.70001220703125, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_990_generated", "manhole_dn": "manhole_991_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.225197304505855, 5866072.657253311946988 ], [ 1387988.247399942483753, 5866112.298415473662317 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_50_E8", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 786.29998779296875, "invlev_up": 783.79998779296875, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_991_generated", "manhole_dn": "manhole_992_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387988.247399942483753, 5866112.298415473662317 ], [ 1388034.037428337847814, 5866130.255607943050563 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_51_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 786.29998779296875, "invlev_up": 783.79998779296875, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_992_generated", "manhole_dn": "manhole_993_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388034.037428337847814, 5866130.255607943050563 ], [ 1387988.210684564430267, 5866144.678138472139835 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_51_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 803.9000244140625, "invlev_up": 783.79998779296875, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_993_generated", "manhole_dn": "manhole_994_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387988.210684564430267, 5866144.678138472139835 ], [ 1387944.406121137319133, 5866164.065103021450341 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_51_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_994_generated", "manhole_dn": "manhole_995_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387944.406121137319133, 5866164.065103021450341 ], [ 1387898.376188111724332, 5866173.560075835324824 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_51_E3", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 827.70001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_995_generated", "manhole_dn": "manhole_996_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387898.376188111724332, 5866173.560075835324824 ], [ 1387861.922560503939167, 5866145.113870099186897 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_51_E4", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_996_generated", "manhole_dn": "manhole_997_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387861.922560503939167, 5866145.113870099186897 ], [ 1387862.597008766839281, 5866099.287653629668057 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_51_E5", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_997_generated", "manhole_dn": "manhole_998_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387862.597008766839281, 5866099.287653629668057 ], [ 1387894.296242429409176, 5866064.31225199252367 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_51_E6", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_998_generated", "manhole_dn": "manhole_999_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387894.296242429409176, 5866064.31225199252367 ], [ 1387918.333023339277133, 5866023.860149594023824 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_51_E7", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_999_generated", "manhole_dn": "manhole_1000_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387918.333023339277133, 5866023.860149594023824 ], [ 1387925.576027213362977, 5865976.462517648003995 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_51_E8", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 804.4000244140625, "invlev_up": 814.20001220703125, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1000_generated", "manhole_dn": "manhole_1001_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387925.576027213362977, 5865976.462517648003995 ], [ 1387926.166851800866425, 5865928.505292822606862 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_51_E9", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1001_generated", "manhole_dn": "manhole_1002_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387926.166851800866425, 5865928.505292822606862 ], [ 1387922.175474973395467, 5865880.628693707287312 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_51_E10", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1002_generated", "manhole_dn": "manhole_1003_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387922.175474973395467, 5865880.628693707287312 ], [ 1387918.184098146157339, 5865832.752094592899084 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_51_E11", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 794.70001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_1003_generated", "manhole_dn": "manhole_1004_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387918.184098146157339, 5865832.752094592899084 ], [ 1387914.316889721900225, 5865784.868878290057182 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_51_E12", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 792.20001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_1004_generated", "manhole_dn": "manhole_851_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387914.316889721900225, 5865784.868878290057182 ], [ 1387913.197226775344461, 5865736.839239663444459 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_52_E0", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_52", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 818.4000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 815.9000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_983_generated", "manhole_dn": "manhole_1005_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388183.697466832818463, 5866137.747996928170323 ], [ 1388133.810787334572524, 5866135.250533932819963 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_52_E1", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_52", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_1005_generated", "manhole_dn": "manhole_1006_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388133.810787334572524, 5866135.250533932819963 ], [ 1388083.924107836093754, 5866132.753070938400924 ] ] } }, -{ "type": "Feature", "properties": { "width": null, "branchtype": "pipe", "bedlev": null, "height": null, "branchid": "pipe_52_E2", "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_52", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 786.29998779296875, "invlev_up": 801.4000244140625, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_1006_generated", "manhole_dn": "manhole_992_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388083.924107836093754, 5866132.753070938400924 ], [ 1388034.037428337847814, 5866130.255607943050563 ] ] } } ->>>>>>> main +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_6_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_1_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389238.298387300921604, 5860147.714495398104191 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_6_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 933.5, "invlev_up": 913.4000244140625, "invlev_dn": 931.0, "manhole_up": "manhole_1_generated", "manhole_dn": "manhole_2_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389238.298387300921604, 5860147.714495398104191 ], [ 1389210.947846550960094, 5860184.343885350972414 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_6_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 933.5, "elevtn_dn": 933.5, "invlev_up": 931.0, "invlev_dn": 931.0, "manhole_up": "manhole_2_generated", "manhole_dn": "manhole_3_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389210.947846550960094, 5860184.343885350972414 ], [ 1389186.961922727525234, 5860223.315261371433735 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_6_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 933.5, "elevtn_dn": 935.5, "invlev_up": 931.0, "invlev_dn": 933.0, "manhole_up": "manhole_3_generated", "manhole_dn": "manhole_4_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389186.961922727525234, 5860223.315261371433735 ], [ 1389162.755598766496405, 5860262.142883376218379 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_6_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 935.5, "invlev_up": 933.0, "invlev_dn": 933.0, "manhole_up": "manhole_4_generated", "manhole_dn": "manhole_5_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389162.755598766496405, 5860262.142883376218379 ], [ 1389136.759307563304901, 5860299.80301527120173 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_6_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 936.5, "invlev_up": 933.0, "invlev_dn": 934.0, "manhole_up": "manhole_5_generated", "manhole_dn": "manhole_6_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389136.759307563304901, 5860299.80301527120173 ], [ 1389109.7301227634307, 5860336.652257356792688 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_6_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 936.5, "elevtn_dn": 941.10003662109375, "invlev_up": 934.0, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_6_generated", "manhole_dn": "manhole_7_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389109.7301227634307, 5860336.652257356792688 ], [ 1389073.18478828552179, 5860363.522737024351954 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_6_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_7_generated", "manhole_dn": "manhole_8_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389073.18478828552179, 5860363.522737024351954 ], [ 1389032.546542100608349, 5860384.329287325032055 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_6_E8", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_8_generated", "manhole_dn": "manhole_9_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389032.546542100608349, 5860384.329287325032055 ], [ 1388989.578410296700895, 5860400.071978960186243 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_6_E9", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_6", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_6", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 951.29998779296875, "invlev_up": 938.60003662109375, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_9_generated", "manhole_dn": "manhole_10_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388989.578410296700895, 5860400.071978960186243 ], [ 1388946.301100668497384, 5860414.883977899327874 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_7_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_11_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389221.905703959986567, 5860123.3256367566064 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_7_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_11_generated", "manhole_dn": "manhole_12_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389221.905703959986567, 5860123.3256367566064 ], [ 1389177.295895804418251, 5860134.962970778346062 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_7_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 919.60003662109375, "invlev_up": 913.4000244140625, "invlev_dn": 917.10003662109375, "manhole_up": "manhole_12_generated", "manhole_dn": "manhole_13_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389177.295895804418251, 5860134.962970778346062 ], [ 1389132.686087648617104, 5860146.600304800085723 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_7_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 919.60003662109375, "elevtn_dn": 919.60003662109375, "invlev_up": 917.10003662109375, "invlev_dn": 917.10003662109375, "manhole_up": "manhole_13_generated", "manhole_dn": "manhole_14_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389132.686087648617104, 5860146.600304800085723 ], [ 1389088.076279493048787, 5860158.237638821825385 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_7_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 919.60003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 917.10003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_14_generated", "manhole_dn": "manhole_15_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389088.076279493048787, 5860158.237638821825385 ], [ 1389044.226173994829878, 5860172.143308508209884 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_7_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 935.60003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_15_generated", "manhole_dn": "manhole_16_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389044.226173994829878, 5860172.143308508209884 ], [ 1389012.527182487538084, 5860198.239755615592003 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_7_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 938.10003662109375, "invlev_up": 935.60003662109375, "invlev_dn": 935.60003662109375, "manhole_up": "manhole_16_generated", "manhole_dn": "manhole_17_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389012.527182487538084, 5860198.239755615592003 ], [ 1388995.773122631013393, 5860240.481283166445792 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_7_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 938.10003662109375, "elevtn_dn": 945.0, "invlev_up": 935.60003662109375, "invlev_dn": 942.5, "manhole_up": "manhole_17_generated", "manhole_dn": "manhole_18_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388995.773122631013393, 5860240.481283166445792 ], [ 1388973.630034049740061, 5860280.918223639950156 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_7_E8", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.0, "elevtn_dn": 951.29998779296875, "invlev_up": 942.5, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_18_generated", "manhole_dn": "manhole_19_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388973.630034049740061, 5860280.918223639950156 ], [ 1388961.171157888136804, 5860324.081192856654525 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_7_E9", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_19_generated", "manhole_dn": "manhole_20_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388961.171157888136804, 5860324.081192856654525 ], [ 1388955.410555170848966, 5860369.690168970264494 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_7_E10", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_7", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_7", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_20_generated", "manhole_dn": "manhole_10_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388955.410555170848966, 5860369.690168970264494 ], [ 1388946.301100668497384, 5860414.883977899327874 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 914.5, "invlev_up": 913.4000244140625, "invlev_dn": 912.0, "manhole_up": "manhole_0_generated", "manhole_dn": "manhole_21_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389266.515512115787715, 5860111.688302734866738 ], [ 1389306.50000010849908, 5860083.476415127515793 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 914.5, "elevtn_dn": 914.5, "invlev_up": 912.0, "invlev_dn": 912.0, "manhole_up": "manhole_21_generated", "manhole_dn": "manhole_22_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389306.50000010849908, 5860083.476415127515793 ], [ 1389355.420758404070511, 5860074.630405306816101 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 914.5, "elevtn_dn": 929.9000244140625, "invlev_up": 912.0, "invlev_dn": 927.4000244140625, "manhole_up": "manhole_22_generated", "manhole_dn": "manhole_23_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389355.420758404070511, 5860074.630405306816101 ], [ 1389389.090761042200029, 5860042.4449307853356 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 929.9000244140625, "elevtn_dn": 955.0, "invlev_up": 927.4000244140625, "invlev_dn": 952.5, "manhole_up": "manhole_23_generated", "manhole_dn": "manhole_24_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389389.090761042200029, 5860042.4449307853356 ], [ 1389404.036260401364416, 5859994.775433851405978 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_24_generated", "manhole_dn": "manhole_25_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389404.036260401364416, 5859994.775433851405978 ], [ 1389418.744130451697856, 5859947.032028519548476 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_25_generated", "manhole_dn": "manhole_26_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389418.744130451697856, 5859947.032028519548476 ], [ 1389423.265342897269875, 5859897.853969652205706 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 975.29998779296875, "invlev_up": 952.5, "invlev_dn": 972.79998779296875, "manhole_up": "manhole_26_generated", "manhole_dn": "manhole_27_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389423.265342897269875, 5859897.853969652205706 ], [ 1389395.831073811277747, 5859856.743154510855675 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 975.29998779296875, "elevtn_dn": 963.0, "invlev_up": 972.79998779296875, "invlev_dn": 960.5, "manhole_up": "manhole_27_generated", "manhole_dn": "manhole_28_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389395.831073811277747, 5859856.743154510855675 ], [ 1389350.827042841585353, 5859839.640478814020753 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E8", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 963.0, "elevtn_dn": 963.0, "invlev_up": 960.5, "invlev_dn": 960.5, "manhole_up": "manhole_28_generated", "manhole_dn": "manhole_29_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389350.827042841585353, 5859839.640478814020753 ], [ 1389303.795788601972163, 5859855.887689013034105 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E9", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 963.0, "elevtn_dn": 945.4000244140625, "invlev_up": 960.5, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_29_generated", "manhole_dn": "manhole_30_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389303.795788601972163, 5859855.887689013034105 ], [ 1389256.284586790716276, 5859863.631580747663975 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E10", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 945.4000244140625, "invlev_up": 942.9000244140625, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_30_generated", "manhole_dn": "manhole_31_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389256.284586790716276, 5859863.631580747663975 ], [ 1389227.308454349869862, 5859823.781623384915292 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E11", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 945.4000244140625, "invlev_up": 942.9000244140625, "invlev_dn": 942.9000244140625, "manhole_up": "manhole_31_generated", "manhole_dn": "manhole_32_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389227.308454349869862, 5859823.781623384915292 ], [ 1389202.745489193825051, 5859780.279727600514889 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E12", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.4000244140625, "elevtn_dn": 959.10003662109375, "invlev_up": 942.9000244140625, "invlev_dn": 956.60003662109375, "manhole_up": "manhole_32_generated", "manhole_dn": "manhole_33_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389202.745489193825051, 5859780.279727600514889 ], [ 1389178.18252403778024, 5859736.777831817045808 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E13", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 959.10003662109375, "elevtn_dn": 944.79998779296875, "invlev_up": 956.60003662109375, "invlev_dn": 942.29998779296875, "manhole_up": "manhole_33_generated", "manhole_dn": "manhole_34_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389178.18252403778024, 5859736.777831817045808 ], [ 1389155.231297271326184, 5859692.450142606161535 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E14", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 944.79998779296875, "elevtn_dn": 944.79998779296875, "invlev_up": 942.29998779296875, "invlev_dn": 942.29998779296875, "manhole_up": "manhole_34_generated", "manhole_dn": "manhole_35_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389155.231297271326184, 5859692.450142606161535 ], [ 1389141.413412723457441, 5859644.883844587020576 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E15", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 944.79998779296875, "elevtn_dn": 952.4000244140625, "invlev_up": 942.29998779296875, "invlev_dn": 949.9000244140625, "manhole_up": "manhole_35_generated", "manhole_dn": "manhole_36_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389141.413412723457441, 5859644.883844587020576 ], [ 1389151.802280035568401, 5859598.61804121825844 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E16", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.4000244140625, "elevtn_dn": 960.70001220703125, "invlev_up": 949.9000244140625, "invlev_dn": 958.20001220703125, "manhole_up": "manhole_36_generated", "manhole_dn": "manhole_37_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389151.802280035568401, 5859598.61804121825844 ], [ 1389191.073854762827978, 5859569.046822287142277 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E17", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 960.70001220703125, "elevtn_dn": 960.70001220703125, "invlev_up": 958.20001220703125, "invlev_dn": 958.20001220703125, "manhole_up": "manhole_37_generated", "manhole_dn": "manhole_38_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389191.073854762827978, 5859569.046822287142277 ], [ 1389239.915165816899389, 5859563.955490378662944 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E18", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 960.70001220703125, "elevtn_dn": 969.60003662109375, "invlev_up": 958.20001220703125, "invlev_dn": 967.10003662109375, "manhole_up": "manhole_38_generated", "manhole_dn": "manhole_39_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389239.915165816899389, 5859563.955490378662944 ], [ 1389289.757686472963542, 5859566.285022127442062 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E19", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 969.60003662109375, "elevtn_dn": 969.60003662109375, "invlev_up": 967.10003662109375, "invlev_dn": 967.10003662109375, "manhole_up": "manhole_39_generated", "manhole_dn": "manhole_40_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389289.757686472963542, 5859566.285022127442062 ], [ 1389339.615828452631831, 5859566.079234052449465 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E20", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 969.60003662109375, "elevtn_dn": 976.29998779296875, "invlev_up": 967.10003662109375, "invlev_dn": 973.79998779296875, "manhole_up": "manhole_40_generated", "manhole_dn": "manhole_41_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389339.615828452631831, 5859566.079234052449465 ], [ 1389387.354307833593339, 5859551.676988741382957 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E21", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 976.29998779296875, "elevtn_dn": 976.29998779296875, "invlev_up": 973.79998779296875, "invlev_dn": 973.79998779296875, "manhole_up": "manhole_41_generated", "manhole_dn": "manhole_42_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389387.354307833593339, 5859551.676988741382957 ], [ 1389428.692968821851537, 5859524.248876142315567 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E22", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 976.29998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 973.79998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_42_generated", "manhole_dn": "manhole_43_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389428.692968821851537, 5859524.248876142315567 ], [ 1389461.138921525795013, 5859486.477508954703808 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E23", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_43_generated", "manhole_dn": "manhole_44_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389461.138921525795013, 5859486.477508954703808 ], [ 1389482.45163832209073, 5859441.487986368127167 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E24", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 966.79998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 964.29998779296875, "manhole_up": "manhole_44_generated", "manhole_dn": "manhole_45_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389482.45163832209073, 5859441.487986368127167 ], [ 1389497.215460168197751, 5859393.906833835877478 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E25", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 966.79998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 964.29998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_45_generated", "manhole_dn": "manhole_46_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389497.215460168197751, 5859393.906833835877478 ], [ 1389508.394423164660111, 5859345.216126504354179 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E26", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 954.79998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_46_generated", "manhole_dn": "manhole_47_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389508.394423164660111, 5859345.216126504354179 ], [ 1389518.522437864448875, 5859296.29671473056078 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E27", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 957.29998779296875, "invlev_up": 954.79998779296875, "invlev_dn": 954.79998779296875, "manhole_up": "manhole_47_generated", "manhole_dn": "manhole_48_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389518.522437864448875, 5859296.29671473056078 ], [ 1389528.588071504374966, 5859247.363727764226496 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E28", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.29998779296875, "elevtn_dn": 950.20001220703125, "invlev_up": 954.79998779296875, "invlev_dn": 947.70001220703125, "manhole_up": "manhole_48_generated", "manhole_dn": "manhole_49_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389528.588071504374966, 5859247.363727764226496 ], [ 1389538.653705144301057, 5859198.43074079696089 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E29", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 950.20001220703125, "elevtn_dn": 957.60003662109375, "invlev_up": 947.70001220703125, "invlev_dn": 955.10003662109375, "manhole_up": "manhole_49_generated", "manhole_dn": "manhole_50_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389538.653705144301057, 5859198.43074079696089 ], [ 1389548.719338784459978, 5859149.497753830626607 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E30", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.60003662109375, "elevtn_dn": 957.60003662109375, "invlev_up": 955.10003662109375, "invlev_dn": 955.10003662109375, "manhole_up": "manhole_50_generated", "manhole_dn": "manhole_51_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389548.719338784459978, 5859149.497753830626607 ], [ 1389558.784972424386069, 5859100.564766863361001 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E31", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.60003662109375, "elevtn_dn": 954.79998779296875, "invlev_up": 955.10003662109375, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_51_generated", "manhole_dn": "manhole_52_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389558.784972424386069, 5859100.564766863361001 ], [ 1389568.85060606431216, 5859051.631779897026718 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E32", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 954.79998779296875, "invlev_up": 952.29998779296875, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_52_generated", "manhole_dn": "manhole_53_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389568.85060606431216, 5859051.631779897026718 ], [ 1389578.916239704471081, 5859002.698792929761112 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E33", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 954.79998779296875, "invlev_up": 952.29998779296875, "invlev_dn": 952.29998779296875, "manhole_up": "manhole_53_generated", "manhole_dn": "manhole_54_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389578.916239704471081, 5859002.698792929761112 ], [ 1389588.981873344397172, 5858953.765805963426828 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E34", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 954.79998779296875, "elevtn_dn": 956.10003662109375, "invlev_up": 952.29998779296875, "invlev_dn": 953.60003662109375, "manhole_up": "manhole_54_generated", "manhole_dn": "manhole_55_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389588.981873344397172, 5858953.765805963426828 ], [ 1389599.047506984323263, 5858904.832818996161222 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E35", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 956.10003662109375, "elevtn_dn": 956.10003662109375, "invlev_up": 953.60003662109375, "invlev_dn": 953.60003662109375, "manhole_up": "manhole_55_generated", "manhole_dn": "manhole_56_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389599.047506984323263, 5858904.832818996161222 ], [ 1389613.243873829254881, 5858857.048414096236229 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E36", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 956.10003662109375, "elevtn_dn": 966.29998779296875, "invlev_up": 953.60003662109375, "invlev_dn": 963.79998779296875, "manhole_up": "manhole_56_generated", "manhole_dn": "manhole_57_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389613.243873829254881, 5858857.048414096236229 ], [ 1389631.198101107496768, 5858810.554778259247541 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E37", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 966.29998779296875, "elevtn_dn": 968.70001220703125, "invlev_up": 963.79998779296875, "invlev_dn": 966.20001220703125, "manhole_up": "manhole_57_generated", "manhole_dn": "manhole_58_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389631.198101107496768, 5858810.554778259247541 ], [ 1389656.490605737781152, 5858767.472956065088511 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E38", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 968.70001220703125, "elevtn_dn": 968.70001220703125, "invlev_up": 966.20001220703125, "invlev_dn": 966.20001220703125, "manhole_up": "manhole_58_generated", "manhole_dn": "manhole_59_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389656.490605737781152, 5858767.472956065088511 ], [ 1389681.956975018838421, 5858724.49639992788434 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E39", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 968.70001220703125, "elevtn_dn": 976.10003662109375, "invlev_up": 966.20001220703125, "invlev_dn": 973.60003662109375, "manhole_up": "manhole_59_generated", "manhole_dn": "manhole_60_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389681.956975018838421, 5858724.49639992788434 ], [ 1389708.407580326776952, 5858682.115747822448611 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E40", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 976.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 973.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_60_generated", "manhole_dn": "manhole_61_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389708.407580326776952, 5858682.115747822448611 ], [ 1389734.858185634715483, 5858639.735095717012882 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E41", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 980.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_61_generated", "manhole_dn": "manhole_62_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389734.858185634715483, 5858639.735095717012882 ], [ 1389761.308790942654014, 5858597.354443610645831 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E42", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 983.10003662109375, "invlev_up": 980.60003662109375, "invlev_dn": 980.60003662109375, "manhole_up": "manhole_62_generated", "manhole_dn": "manhole_63_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389761.308790942654014, 5858597.354443610645831 ], [ 1389787.759396250825375, 5858554.973791505210102 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E43", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 983.10003662109375, "elevtn_dn": 993.29998779296875, "invlev_up": 980.60003662109375, "invlev_dn": 990.79998779296875, "manhole_up": "manhole_63_generated", "manhole_dn": "manhole_64_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389787.759396250825375, 5858554.973791505210102 ], [ 1389814.210001558763906, 5858512.593139399774373 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E44", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 993.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 990.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_64_generated", "manhole_dn": "manhole_65_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389814.210001558763906, 5858512.593139399774373 ], [ 1389840.660606866702437, 5858470.212487293407321 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E45", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 995.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_65_generated", "manhole_dn": "manhole_66_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389840.660606866702437, 5858470.212487293407321 ], [ 1389867.111212174640968, 5858427.831835187971592 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E46", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 998.29998779296875, "invlev_up": 995.79998779296875, "invlev_dn": 995.79998779296875, "manhole_up": "manhole_66_generated", "manhole_dn": "manhole_67_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389867.111212174640968, 5858427.831835187971592 ], [ 1389911.240854029776528, 5858417.074701879173517 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E47", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 998.29998779296875, "elevtn_dn": 1006.2000122070312, "invlev_up": 995.79998779296875, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_67_generated", "manhole_dn": "manhole_68_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389911.240854029776528, 5858417.074701879173517 ], [ 1389940.226093058940023, 5858455.739661679603159 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E48", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1006.2000122070312, "invlev_up": 1003.7000122070312, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_68_generated", "manhole_dn": "manhole_69_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389940.226093058940023, 5858455.739661679603159 ], [ 1389959.842267287895083, 5858501.684845351614058 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E49", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1006.2000122070312, "invlev_up": 1003.7000122070312, "invlev_dn": 1003.7000122070312, "manhole_up": "manhole_69_generated", "manhole_dn": "manhole_70_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389959.842267287895083, 5858501.684845351614058 ], [ 1389983.028926897095516, 5858544.760824581608176 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E50", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1006.2000122070312, "elevtn_dn": 1036.9000244140625, "invlev_up": 1003.7000122070312, "invlev_dn": 1034.4000244140625, "manhole_up": "manhole_70_generated", "manhole_dn": "manhole_71_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389983.028926897095516, 5858544.760824581608176 ], [ 1390026.879799408372492, 5858567.986969069577754 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E51", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1036.9000244140625, "elevtn_dn": 1036.9000244140625, "invlev_up": 1034.4000244140625, "invlev_dn": 1034.4000244140625, "manhole_up": "manhole_71_generated", "manhole_dn": "manhole_72_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390026.879799408372492, 5858567.986969069577754 ], [ 1390075.455719914287329, 5858577.981817713007331 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E52", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1036.9000244140625, "elevtn_dn": 1032.9000244140625, "invlev_up": 1034.4000244140625, "invlev_dn": 1030.4000244140625, "manhole_up": "manhole_72_generated", "manhole_dn": "manhole_73_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390075.455719914287329, 5858577.981817713007331 ], [ 1390124.934819511603564, 5858584.860858413390815 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E53", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1032.9000244140625, "elevtn_dn": 1032.9000244140625, "invlev_up": 1030.4000244140625, "invlev_dn": 1030.4000244140625, "manhole_up": "manhole_73_generated", "manhole_dn": "manhole_74_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390124.934819511603564, 5858584.860858413390815 ], [ 1390174.385966305155307, 5858591.894069475121796 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E54", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1032.9000244140625, "elevtn_dn": 1016.6000366210938, "invlev_up": 1030.4000244140625, "invlev_dn": 1014.1000366210938, "manhole_up": "manhole_74_generated", "manhole_dn": "manhole_75_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390174.385966305155307, 5858591.894069475121796 ], [ 1390224.28731826832518, 5858594.262458441779017 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E55", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1016.6000366210938, "elevtn_dn": 1016.6000366210938, "invlev_up": 1014.1000366210938, "invlev_dn": 1014.1000366210938, "manhole_up": "manhole_75_generated", "manhole_dn": "manhole_76_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390224.28731826832518, 5858594.262458441779017 ], [ 1390273.630285855382681, 5858589.561945637688041 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E56", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1016.6000366210938, "elevtn_dn": 1012.1000366210938, "invlev_up": 1014.1000366210938, "invlev_dn": 1009.6000366210938, "manhole_up": "manhole_76_generated", "manhole_dn": "manhole_77_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390273.630285855382681, 5858589.561945637688041 ], [ 1390322.239480242831632, 5858578.072306710295379 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E57", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1012.1000366210938, "elevtn_dn": 1012.1000366210938, "invlev_up": 1009.6000366210938, "invlev_dn": 1009.6000366210938, "manhole_up": "manhole_77_generated", "manhole_dn": "manhole_78_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390322.239480242831632, 5858578.072306710295379 ], [ 1390371.99352877959609, 5858575.309522898867726 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E58", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1012.1000366210938, "elevtn_dn": 1011.7000122070312, "invlev_up": 1009.6000366210938, "invlev_dn": 1009.2000122070312, "manhole_up": "manhole_78_generated", "manhole_dn": "manhole_79_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390371.99352877959609, 5858575.309522898867726 ], [ 1390419.13544210139662, 5858559.59311543405056 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E59", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1011.7000122070312, "elevtn_dn": 981.5, "invlev_up": 1009.2000122070312, "invlev_dn": 979.0, "manhole_up": "manhole_79_generated", "manhole_dn": "manhole_80_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390419.13544210139662, 5858559.59311543405056 ], [ 1390453.401623640675098, 5858524.246223840862513 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E60", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 981.5, "elevtn_dn": 995.70001220703125, "invlev_up": 979.0, "invlev_dn": 993.20001220703125, "manhole_up": "manhole_80_generated", "manhole_dn": "manhole_81_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390453.401623640675098, 5858524.246223840862513 ], [ 1390496.749499944737181, 5858504.780008735135198 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E61", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 995.70001220703125, "elevtn_dn": 995.70001220703125, "invlev_up": 993.20001220703125, "invlev_dn": 993.20001220703125, "manhole_up": "manhole_81_generated", "manhole_dn": "manhole_82_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390496.749499944737181, 5858504.780008735135198 ], [ 1390546.470755147282034, 5858499.993151630274951 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E62", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 995.70001220703125, "elevtn_dn": 1005.9000244140625, "invlev_up": 993.20001220703125, "invlev_dn": 1003.4000244140625, "manhole_up": "manhole_82_generated", "manhole_dn": "manhole_83_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390546.470755147282034, 5858499.993151630274951 ], [ 1390596.395264241611585, 5858498.177226040512323 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E63", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1005.9000244140625, "elevtn_dn": 1005.9000244140625, "invlev_up": 1003.4000244140625, "invlev_dn": 1003.4000244140625, "manhole_up": "manhole_83_generated", "manhole_dn": "manhole_84_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390596.395264241611585, 5858498.177226040512323 ], [ 1390646.319773336173967, 5858496.361300451681018 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E64", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1005.9000244140625, "elevtn_dn": 1013.6000366210938, "invlev_up": 1003.4000244140625, "invlev_dn": 1011.1000366210938, "manhole_up": "manhole_84_generated", "manhole_dn": "manhole_85_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390646.319773336173967, 5858496.361300451681018 ], [ 1390696.244282430503517, 5858494.545374862849712 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E65", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1013.6000366210938, "elevtn_dn": 1013.6000366210938, "invlev_up": 1011.1000366210938, "invlev_dn": 1011.1000366210938, "manhole_up": "manhole_85_generated", "manhole_dn": "manhole_86_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390696.244282430503517, 5858494.545374862849712 ], [ 1390746.168791524833068, 5858492.729449273087084 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E66", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1013.6000366210938, "elevtn_dn": 1019.1000366210938, "invlev_up": 1011.1000366210938, "invlev_dn": 1016.6000366210938, "manhole_up": "manhole_86_generated", "manhole_dn": "manhole_87_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390746.168791524833068, 5858492.729449273087084 ], [ 1390796.09330061939545, 5858490.913523684255779 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E67", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1019.1000366210938, "elevtn_dn": 1025.800048828125, "invlev_up": 1016.6000366210938, "invlev_dn": 1023.300048828125, "manhole_up": "manhole_87_generated", "manhole_dn": "manhole_88_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390796.09330061939545, 5858490.913523684255779 ], [ 1390846.017809713725001, 5858489.097598095424473 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E68", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1025.800048828125, "elevtn_dn": 1025.800048828125, "invlev_up": 1023.300048828125, "invlev_dn": 1023.300048828125, "manhole_up": "manhole_88_generated", "manhole_dn": "manhole_89_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390846.017809713725001, 5858489.097598095424473 ], [ 1390895.942318808054551, 5858487.281672505661845 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E69", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1025.800048828125, "elevtn_dn": 1029.2000732421875, "invlev_up": 1023.300048828125, "invlev_dn": 1026.7000732421875, "manhole_up": "manhole_89_generated", "manhole_dn": "manhole_90_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390895.942318808054551, 5858487.281672505661845 ], [ 1390945.364988021552563, 5858492.061225635930896 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E70", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1029.2000732421875, "elevtn_dn": 1029.2000732421875, "invlev_up": 1026.7000732421875, "invlev_dn": 1026.7000732421875, "manhole_up": "manhole_90_generated", "manhole_dn": "manhole_91_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390945.364988021552563, 5858492.061225635930896 ], [ 1390994.440001817885786, 5858501.409873396158218 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E71", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1029.2000732421875, "elevtn_dn": 1033.2000732421875, "invlev_up": 1026.7000732421875, "invlev_dn": 1030.7000732421875, "manhole_up": "manhole_91_generated", "manhole_dn": "manhole_92_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390994.440001817885786, 5858501.409873396158218 ], [ 1391040.341196772176772, 5858520.979841153137386 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E72", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1033.2000732421875, "elevtn_dn": 1033.2000732421875, "invlev_up": 1030.7000732421875, "invlev_dn": 1030.7000732421875, "manhole_up": "manhole_92_generated", "manhole_dn": "manhole_93_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391040.341196772176772, 5858520.979841153137386 ], [ 1391086.683747049886733, 5858538.717575071379542 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E73", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1033.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1030.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_93_generated", "manhole_dn": "manhole_94_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391086.683747049886733, 5858538.717575071379542 ], [ 1391131.822940095094964, 5858523.93243224080652 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E74", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_94_generated", "manhole_dn": "manhole_95_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391131.822940095094964, 5858523.93243224080652 ], [ 1391153.157672074623406, 5858479.460670891217887 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E75", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1038.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1035.7000732421875, "manhole_up": "manhole_95_generated", "manhole_dn": "manhole_96_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391153.157672074623406, 5858479.460670891217887 ], [ 1391192.49590603238903, 5858451.67839205916971 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E76", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1038.2000732421875, "elevtn_dn": 1044.2000732421875, "invlev_up": 1035.7000732421875, "invlev_dn": 1041.7000732421875, "manhole_up": "manhole_96_generated", "manhole_dn": "manhole_97_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391192.49590603238903, 5858451.67839205916971 ], [ 1391240.64117361814715, 5858438.460245226509869 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E77", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1044.2000732421875, "elevtn_dn": 1044.2000732421875, "invlev_up": 1041.7000732421875, "invlev_dn": 1041.7000732421875, "manhole_up": "manhole_97_generated", "manhole_dn": "manhole_98_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391240.64117361814715, 5858438.460245226509869 ], [ 1391289.211760010803118, 5858426.770406410098076 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E78", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1044.2000732421875, "elevtn_dn": 1060.0999755859375, "invlev_up": 1041.7000732421875, "invlev_dn": 1057.5999755859375, "manhole_up": "manhole_98_generated", "manhole_dn": "manhole_99_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391289.211760010803118, 5858426.770406410098076 ], [ 1391337.782346403226256, 5858415.080567593686283 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E79", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1060.0999755859375, "elevtn_dn": 1023.0, "invlev_up": 1057.5999755859375, "invlev_dn": 1020.5, "manhole_up": "manhole_99_generated", "manhole_dn": "manhole_100_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391337.782346403226256, 5858415.080567593686283 ], [ 1391386.352932795882225, 5858403.390728777274489 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E80", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1023.0, "elevtn_dn": 1032.7000732421875, "invlev_up": 1020.5, "invlev_dn": 1030.2000732421875, "manhole_up": "manhole_100_generated", "manhole_dn": "manhole_101_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391386.352932795882225, 5858403.390728777274489 ], [ 1391434.923519188305363, 5858391.700889961794019 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E81", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1032.7000732421875, "elevtn_dn": 1032.7000732421875, "invlev_up": 1030.2000732421875, "invlev_dn": 1030.2000732421875, "manhole_up": "manhole_101_generated", "manhole_dn": "manhole_102_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391434.923519188305363, 5858391.700889961794019 ], [ 1391483.494105580961332, 5858380.011051145382226 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E82", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1032.7000732421875, "elevtn_dn": 1040.7000732421875, "invlev_up": 1030.2000732421875, "invlev_dn": 1038.2000732421875, "manhole_up": "manhole_102_generated", "manhole_dn": "manhole_103_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391483.494105580961332, 5858380.011051145382226 ], [ 1391532.464345134794712, 5858375.802092345431447 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E83", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1040.7000732421875, "elevtn_dn": 1040.7000732421875, "invlev_up": 1038.2000732421875, "invlev_dn": 1038.2000732421875, "manhole_up": "manhole_103_generated", "manhole_dn": "manhole_104_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391532.464345134794712, 5858375.802092345431447 ], [ 1391579.680508555145934, 5858389.753166117705405 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E84", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1040.7000732421875, "elevtn_dn": 1094.5999755859375, "invlev_up": 1038.2000732421875, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_104_generated", "manhole_dn": "manhole_105_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391579.680508555145934, 5858389.753166117705405 ], [ 1391615.043221722124144, 5858422.374543751589954 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E85", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1094.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_105_generated", "manhole_dn": "manhole_106_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391615.043221722124144, 5858422.374543751589954 ], [ 1391633.654095822479576, 5858468.206737855449319 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E86", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1094.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1092.0999755859375, "manhole_up": "manhole_106_generated", "manhole_dn": "manhole_107_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391633.654095822479576, 5858468.206737855449319 ], [ 1391675.556871910346672, 5858492.042518986389041 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E87", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1094.5999755859375, "elevtn_dn": 1100.5999755859375, "invlev_up": 1092.0999755859375, "invlev_dn": 1098.0999755859375, "manhole_up": "manhole_107_generated", "manhole_dn": "manhole_108_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391675.556871910346672, 5858492.042518986389041 ], [ 1391725.165284683462232, 5858493.223410680890083 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E88", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1100.5999755859375, "elevtn_dn": 1092.7000732421875, "invlev_up": 1098.0999755859375, "invlev_dn": 1090.2000732421875, "manhole_up": "manhole_108_generated", "manhole_dn": "manhole_109_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391725.165284683462232, 5858493.223410680890083 ], [ 1391774.025632579578087, 5858482.968163449317217 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E89", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1092.7000732421875, "elevtn_dn": 1092.7000732421875, "invlev_up": 1090.2000732421875, "invlev_dn": 1090.2000732421875, "manhole_up": "manhole_109_generated", "manhole_dn": "manhole_110_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391774.025632579578087, 5858482.968163449317217 ], [ 1391822.748904443578795, 5858472.800456050783396 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E90", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1092.7000732421875, "elevtn_dn": 1086.5, "invlev_up": 1090.2000732421875, "invlev_dn": 1084.0, "manhole_up": "manhole_110_generated", "manhole_dn": "manhole_111_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391822.748904443578795, 5858472.800456050783396 ], [ 1391872.520155652426183, 5858474.254766616038978 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E91", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1086.5, "elevtn_dn": 1086.5, "invlev_up": 1084.0, "invlev_dn": 1084.0, "manhole_up": "manhole_111_generated", "manhole_dn": "manhole_112_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391872.520155652426183, 5858474.254766616038978 ], [ 1391922.32820742437616, 5858478.116394865326583 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E92", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1086.5, "elevtn_dn": 1097.300048828125, "invlev_up": 1084.0, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_112_generated", "manhole_dn": "manhole_113_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391922.32820742437616, 5858478.116394865326583 ], [ 1391972.136259196558967, 5858481.978023114614189 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E93", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_113_generated", "manhole_dn": "manhole_114_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391972.136259196558967, 5858481.978023114614189 ], [ 1392014.088137687649578, 5858507.265420926734805 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E94", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_114_generated", "manhole_dn": "manhole_115_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392014.088137687649578, 5858507.265420926734805 ], [ 1392052.00577615830116, 5858538.949620860628784 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E95", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1097.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1094.800048828125, "manhole_up": "manhole_115_generated", "manhole_dn": "manhole_116_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392052.00577615830116, 5858538.949620860628784 ], [ 1392100.993319420609623, 5858548.746293722651899 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E96", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1097.300048828125, "elevtn_dn": 1135.300048828125, "invlev_up": 1094.800048828125, "invlev_dn": 1132.800048828125, "manhole_up": "manhole_116_generated", "manhole_dn": "manhole_117_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392100.993319420609623, 5858548.746293722651899 ], [ 1392149.980862683150917, 5858558.542966585606337 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E97", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1135.300048828125, "elevtn_dn": 1135.300048828125, "invlev_up": 1132.800048828125, "invlev_dn": 1132.800048828125, "manhole_up": "manhole_117_generated", "manhole_dn": "manhole_118_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392149.980862683150917, 5858558.542966585606337 ], [ 1392198.767287699971348, 5858569.25206732749939 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E98", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1135.300048828125, "elevtn_dn": 1137.5999755859375, "invlev_up": 1132.800048828125, "invlev_dn": 1135.0999755859375, "manhole_up": "manhole_118_generated", "manhole_dn": "manhole_119_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392198.767287699971348, 5858569.25206732749939 ], [ 1392247.333906656363979, 5858580.958378325216472 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E99", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1137.5999755859375, "elevtn_dn": 1137.5999755859375, "invlev_up": 1135.0999755859375, "invlev_dn": 1135.0999755859375, "manhole_up": "manhole_119_generated", "manhole_dn": "manhole_120_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392247.333906656363979, 5858580.958378325216472 ], [ 1392295.900525612989441, 5858592.664689323864877 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E100", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1137.5999755859375, "elevtn_dn": 1145.0999755859375, "invlev_up": 1135.0999755859375, "invlev_dn": 1142.5999755859375, "manhole_up": "manhole_120_generated", "manhole_dn": "manhole_121_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392295.900525612989441, 5858592.664689323864877 ], [ 1392344.467144569614902, 5858604.371000322513282 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E101", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1145.0999755859375, "elevtn_dn": 1145.0999755859375, "invlev_up": 1142.5999755859375, "invlev_dn": 1142.5999755859375, "manhole_up": "manhole_121_generated", "manhole_dn": "manhole_122_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392344.467144569614902, 5858604.371000322513282 ], [ 1392389.908255772199482, 5858624.575613909401 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E102", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1145.0999755859375, "elevtn_dn": 1140.5, "invlev_up": 1142.5999755859375, "invlev_dn": 1138.0, "manhole_up": "manhole_122_generated", "manhole_dn": "manhole_123_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392389.908255772199482, 5858624.575613909401 ], [ 1392425.081700494978577, 5858659.315580372698605 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E103", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1140.5, "elevtn_dn": 1169.300048828125, "invlev_up": 1138.0, "invlev_dn": 1166.800048828125, "manhole_up": "manhole_123_generated", "manhole_dn": "manhole_124_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392425.081700494978577, 5858659.315580372698605 ], [ 1392458.203119478421286, 5858696.715123130939901 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E104", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1169.300048828125, "elevtn_dn": 1169.300048828125, "invlev_up": 1166.800048828125, "invlev_dn": 1166.800048828125, "manhole_up": "manhole_124_generated", "manhole_dn": "manhole_125_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392458.203119478421286, 5858696.715123130939901 ], [ 1392491.324538461863995, 5858734.114665890112519 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E105", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1169.300048828125, "elevtn_dn": 1165.5, "invlev_up": 1166.800048828125, "invlev_dn": 1163.0, "manhole_up": "manhole_125_generated", "manhole_dn": "manhole_126_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392491.324538461863995, 5858734.114665890112519 ], [ 1392528.963966277893633, 5858766.460637149401009 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E106", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1165.5, "elevtn_dn": 1165.5, "invlev_up": 1163.0, "invlev_dn": 1163.0, "manhole_up": "manhole_126_generated", "manhole_dn": "manhole_127_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392528.963966277893633, 5858766.460637149401009 ], [ 1392573.284122244687751, 5858789.391092935577035 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E107", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1165.5, "elevtn_dn": 1157.0999755859375, "invlev_up": 1163.0, "invlev_dn": 1154.5999755859375, "manhole_up": "manhole_127_generated", "manhole_dn": "manhole_128_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392573.284122244687751, 5858789.391092935577035 ], [ 1392618.033192394766957, 5858811.600886153057218 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E108", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1157.0999755859375, "elevtn_dn": 1184.800048828125, "invlev_up": 1154.5999755859375, "invlev_dn": 1182.300048828125, "manhole_up": "manhole_128_generated", "manhole_dn": "manhole_129_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392618.033192394766957, 5858811.600886153057218 ], [ 1392666.730896146036685, 5858821.011833874508739 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E109", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1184.800048828125, "elevtn_dn": 1141.2000732421875, "invlev_up": 1182.300048828125, "invlev_dn": 1138.7000732421875, "manhole_up": "manhole_129_generated", "manhole_dn": "manhole_130_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392666.730896146036685, 5858821.011833874508739 ], [ 1392714.397227015113458, 5858809.184477739967406 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E110", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1141.2000732421875, "elevtn_dn": 1141.2000732421875, "invlev_up": 1138.7000732421875, "invlev_dn": 1138.7000732421875, "manhole_up": "manhole_130_generated", "manhole_dn": "manhole_131_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392714.397227015113458, 5858809.184477739967406 ], [ 1392761.799294820055366, 5858794.231293976306915 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E111", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1141.2000732421875, "elevtn_dn": 1137.4000244140625, "invlev_up": 1138.7000732421875, "invlev_dn": 1134.9000244140625, "manhole_up": "manhole_131_generated", "manhole_dn": "manhole_132_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392761.799294820055366, 5858794.231293976306915 ], [ 1392810.095712865469977, 5858797.830352782271802 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E112", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1137.4000244140625, "elevtn_dn": 1137.4000244140625, "invlev_up": 1134.9000244140625, "invlev_dn": 1134.9000244140625, "manhole_up": "manhole_132_generated", "manhole_dn": "manhole_133_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392810.095712865469977, 5858797.830352782271802 ], [ 1392855.660074200481176, 5858817.529770986177027 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E113", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1137.4000244140625, "elevtn_dn": 1169.5, "invlev_up": 1134.9000244140625, "invlev_dn": 1167.0, "manhole_up": "manhole_133_generated", "manhole_dn": "manhole_134_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392855.660074200481176, 5858817.529770986177027 ], [ 1392904.672455, 5858826.347064822912216 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E114", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_134_generated", "manhole_dn": "manhole_135_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392904.672455, 5858826.347064822912216 ], [ 1392949.505032581742853, 5858846.393358059227467 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E115", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_135_generated", "manhole_dn": "manhole_136_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392949.505032581742853, 5858846.393358059227467 ], [ 1392993.956312821945176, 5858868.358838438987732 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E116", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1169.5, "invlev_up": 1167.0, "invlev_dn": 1167.0, "manhole_up": "manhole_136_generated", "manhole_dn": "manhole_137_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392993.956312821945176, 5858868.358838438987732 ], [ 1393042.160067020915449, 5858881.479519641026855 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E117", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1169.5, "elevtn_dn": 1162.0, "invlev_up": 1167.0, "invlev_dn": 1159.5, "manhole_up": "manhole_137_generated", "manhole_dn": "manhole_138_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393042.160067020915449, 5858881.479519641026855 ], [ 1393090.363821219652891, 5858894.600200843065977 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E118", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1162.0, "elevtn_dn": 1162.0, "invlev_up": 1159.5, "invlev_dn": 1159.5, "manhole_up": "manhole_138_generated", "manhole_dn": "manhole_139_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393090.363821219652891, 5858894.600200843065977 ], [ 1393138.877780271228403, 5858905.382868006825447 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E119", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1162.0, "elevtn_dn": 1152.0999755859375, "invlev_up": 1159.5, "invlev_dn": 1149.5999755859375, "manhole_up": "manhole_139_generated", "manhole_dn": "manhole_140_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393138.877780271228403, 5858905.382868006825447 ], [ 1393188.835210436256602, 5858905.286093098111451 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E120", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1152.0999755859375, "elevtn_dn": 1152.0999755859375, "invlev_up": 1149.5999755859375, "invlev_dn": 1149.5999755859375, "manhole_up": "manhole_140_generated", "manhole_dn": "manhole_141_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393188.835210436256602, 5858905.286093098111451 ], [ 1393237.248238409170881, 5858916.599204055964947 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E121", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1152.0999755859375, "elevtn_dn": 1147.300048828125, "invlev_up": 1149.5999755859375, "invlev_dn": 1144.800048828125, "manhole_up": "manhole_141_generated", "manhole_dn": "manhole_142_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393237.248238409170881, 5858916.599204055964947 ], [ 1393278.15638761385344, 5858943.766047672368586 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E122", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1147.300048828125, "elevtn_dn": 1182.7000732421875, "invlev_up": 1144.800048828125, "invlev_dn": 1180.2000732421875, "manhole_up": "manhole_142_generated", "manhole_dn": "manhole_143_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393278.15638761385344, 5858943.766047672368586 ], [ 1393316.553906054003164, 5858975.725158606655896 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E123", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1182.7000732421875, "elevtn_dn": 1180.0999755859375, "invlev_up": 1180.2000732421875, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_143_generated", "manhole_dn": "manhole_144_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393316.553906054003164, 5858975.725158606655896 ], [ 1393354.951424494385719, 5859007.684269540011883 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E124", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1180.0999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_144_generated", "manhole_dn": "manhole_145_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393354.951424494385719, 5859007.684269540011883 ], [ 1393393.348942934535444, 5859039.643380474299192 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E125", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1180.0999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1177.5999755859375, "manhole_up": "manhole_145_generated", "manhole_dn": "manhole_146_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393393.348942934535444, 5859039.643380474299192 ], [ 1393431.746461374685168, 5859071.602491408586502 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E126", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1180.0999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1177.5999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_146_generated", "manhole_dn": "manhole_147_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393431.746461374685168, 5859071.602491408586502 ], [ 1393472.672340910183266, 5859100.089053857140243 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E127", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1200.0999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_147_generated", "manhole_dn": "manhole_148_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393472.672340910183266, 5859100.089053857140243 ], [ 1393507.678647378925234, 5859134.262682756409049 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E128", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1202.5999755859375, "invlev_up": 1200.0999755859375, "invlev_dn": 1200.0999755859375, "manhole_up": "manhole_148_generated", "manhole_dn": "manhole_149_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393507.678647378925234, 5859134.262682756409049 ], [ 1393492.637579936999828, 5859179.667013085447252 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E129", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1202.5999755859375, "elevtn_dn": 1232.300048828125, "invlev_up": 1200.0999755859375, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_149_generated", "manhole_dn": "manhole_150_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393492.637579936999828, 5859179.667013085447252 ], [ 1393472.727902054553851, 5859225.064155456610024 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E130", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_150_generated", "manhole_dn": "manhole_151_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393472.727902054553851, 5859225.064155456610024 ], [ 1393467.563765458529815, 5859274.587596206925809 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E131", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_151_generated", "manhole_dn": "manhole_152_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393467.563765458529815, 5859274.587596206925809 ], [ 1393473.51405850565061, 5859323.8850102070719 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E132", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1232.300048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1229.800048828125, "manhole_up": "manhole_152_generated", "manhole_dn": "manhole_153_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393473.51405850565061, 5859323.8850102070719 ], [ 1393507.773820924572647, 5859356.614802500233054 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E133", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1232.300048828125, "elevtn_dn": 1214.800048828125, "invlev_up": 1229.800048828125, "invlev_dn": 1212.300048828125, "manhole_up": "manhole_153_generated", "manhole_dn": "manhole_154_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393507.773820924572647, 5859356.614802500233054 ], [ 1393555.824224345618859, 5859349.253152369521558 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E134", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1214.800048828125, "elevtn_dn": 1214.800048828125, "invlev_up": 1212.300048828125, "invlev_dn": 1212.300048828125, "manhole_up": "manhole_154_generated", "manhole_dn": "manhole_155_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393555.824224345618859, 5859349.253152369521558 ], [ 1393591.00338595919311, 5859314.794959847815335 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E135", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1214.800048828125, "elevtn_dn": 1191.0999755859375, "invlev_up": 1212.300048828125, "invlev_dn": 1188.5999755859375, "manhole_up": "manhole_155_generated", "manhole_dn": "manhole_156_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393591.00338595919311, 5859314.794959847815335 ], [ 1393633.153639519121498, 5859288.066565420478582 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E136", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1191.0999755859375, "elevtn_dn": 1191.0999755859375, "invlev_up": 1188.5999755859375, "invlev_dn": 1188.5999755859375, "manhole_up": "manhole_156_generated", "manhole_dn": "manhole_157_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393633.153639519121498, 5859288.066565420478582 ], [ 1393673.123904188396409, 5859258.097712650895119 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E137", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1191.0999755859375, "elevtn_dn": 1144.300048828125, "invlev_up": 1188.5999755859375, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_157_generated", "manhole_dn": "manhole_158_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393673.123904188396409, 5859258.097712650895119 ], [ 1393720.523227575467899, 5859244.838272913359106 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E138", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1144.300048828125, "invlev_up": 1141.800048828125, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_158_generated", "manhole_dn": "manhole_159_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393720.523227575467899, 5859244.838272913359106 ], [ 1393765.710014625452459, 5859224.569284616038203 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E139", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1144.300048828125, "invlev_up": 1141.800048828125, "invlev_dn": 1141.800048828125, "manhole_up": "manhole_159_generated", "manhole_dn": "manhole_160_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393765.710014625452459, 5859224.569284616038203 ], [ 1393806.409210936399177, 5859195.609256223775446 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_8_E140", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_8", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_8", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1144.300048828125, "elevtn_dn": 1112.5, "invlev_up": 1141.800048828125, "invlev_dn": 1110.0, "manhole_up": "manhole_160_generated", "manhole_dn": "manhole_161_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1393806.409210936399177, 5859195.609256223775446 ], [ 1393846.866742686368525, 5859166.301538489758968 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1045", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 968.29998779296875, "invlev_up": 965.79998779296875, "invlev_dn": 965.79998779296875, "manhole_up": "manhole_162_generated", "manhole_dn": "manhole_163_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388521.257592596346512, 5855362.027613477781415 ], [ 1388472.030306826578453, 5855370.543775821104646 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1046", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 968.29998779296875, "invlev_up": 965.79998779296875, "invlev_dn": 965.79998779296875, "manhole_up": "manhole_163_generated", "manhole_dn": "manhole_164_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388472.030306826578453, 5855370.543775821104646 ], [ 1388439.000347282737494, 5855407.802592809312046 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1047", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 968.29998779296875, "elevtn_dn": 964.5, "invlev_up": 965.79998779296875, "invlev_dn": 962.0, "manhole_up": "manhole_164_generated", "manhole_dn": "manhole_165_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388439.000347282737494, 5855407.802592809312046 ], [ 1388400.196091859601438, 5855436.014134516008198 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1048", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 964.5, "invlev_up": 962.0, "invlev_dn": 962.0, "manhole_up": "manhole_165_generated", "manhole_dn": "manhole_166_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388400.196091859601438, 5855436.014134516008198 ], [ 1388351.33823574683629, 5855446.634319253265858 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1049", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 981.9000244140625, "invlev_up": 962.0, "invlev_dn": 979.4000244140625, "manhole_up": "manhole_166_generated", "manhole_dn": "manhole_167_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388351.33823574683629, 5855446.634319253265858 ], [ 1388301.961881892289966, 5855453.847477887757123 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1050", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 981.9000244140625, "elevtn_dn": 981.9000244140625, "invlev_up": 979.4000244140625, "invlev_dn": 979.4000244140625, "manhole_up": "manhole_167_generated", "manhole_dn": "manhole_168_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388301.961881892289966, 5855453.847477887757123 ], [ 1388252.297577269142494, 5855451.260453455150127 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1051", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 981.9000244140625, "elevtn_dn": 973.70001220703125, "invlev_up": 979.4000244140625, "invlev_dn": 971.20001220703125, "manhole_up": "manhole_168_generated", "manhole_dn": "manhole_169_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388252.297577269142494, 5855451.260453455150127 ], [ 1388202.479659734526649, 5855455.508814659900963 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1052", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 973.70001220703125, "elevtn_dn": 961.70001220703125, "invlev_up": 971.20001220703125, "invlev_dn": 959.20001220703125, "manhole_up": "manhole_169_generated", "manhole_dn": "manhole_170_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388202.479659734526649, 5855455.508814659900963 ], [ 1388152.683455461403355, 5855460.015516467392445 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1053", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 961.70001220703125, "elevtn_dn": 961.70001220703125, "invlev_up": 959.20001220703125, "invlev_dn": 959.20001220703125, "manhole_up": "manhole_170_generated", "manhole_dn": "manhole_171_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388152.683455461403355, 5855460.015516467392445 ], [ 1388104.622611842118204, 5855473.253733876161277 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1054", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 961.70001220703125, "elevtn_dn": 945.79998779296875, "invlev_up": 959.20001220703125, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_171_generated", "manhole_dn": "manhole_172_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388104.622611842118204, 5855473.253733876161277 ], [ 1388057.00563437351957, 5855488.445189393125474 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1055", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 945.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_172_generated", "manhole_dn": "manhole_173_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388057.00563437351957, 5855488.445189393125474 ], [ 1388011.292356542311609, 5855508.700276436284184 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1056", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 945.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 943.29998779296875, "manhole_up": "manhole_173_generated", "manhole_dn": "manhole_174_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388011.292356542311609, 5855508.700276436284184 ], [ 1387969.221702651120722, 5855535.246164590120316 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1057", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.79998779296875, "elevtn_dn": 930.79998779296875, "invlev_up": 943.29998779296875, "invlev_dn": 928.29998779296875, "manhole_up": "manhole_174_generated", "manhole_dn": "manhole_175_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.221702651120722, 5855535.246164590120316 ], [ 1387935.863196024205536, 5855572.491061648353934 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1058", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 930.79998779296875, "elevtn_dn": 957.10003662109375, "invlev_up": 928.29998779296875, "invlev_dn": 954.60003662109375, "manhole_up": "manhole_175_generated", "manhole_dn": "manhole_176_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387935.863196024205536, 5855572.491061648353934 ], [ 1387904.610231971368194, 5855611.432584651745856 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1059", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.10003662109375, "elevtn_dn": 947.4000244140625, "invlev_up": 954.60003662109375, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_176_generated", "manhole_dn": "manhole_177_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387904.610231971368194, 5855611.432584651745856 ], [ 1387869.335365027422085, 5855646.852918352000415 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1060", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 947.4000244140625, "invlev_up": 944.9000244140625, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_177_generated", "manhole_dn": "manhole_178_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387869.335365027422085, 5855646.852918352000415 ], [ 1387831.783288773847744, 5855679.735664095729589 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1061", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 947.4000244140625, "invlev_up": 944.9000244140625, "invlev_dn": 944.9000244140625, "manhole_up": "manhole_178_generated", "manhole_dn": "manhole_179_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387831.783288773847744, 5855679.735664095729589 ], [ 1387791.509416193468496, 5855708.923279576934874 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1062", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 947.4000244140625, "elevtn_dn": 933.29998779296875, "invlev_up": 944.9000244140625, "invlev_dn": 930.79998779296875, "manhole_up": "manhole_179_generated", "manhole_dn": "manhole_180_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387791.509416193468496, 5855708.923279576934874 ], [ 1387742.459816947113723, 5855717.213657722808421 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1063", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 933.29998779296875, "elevtn_dn": 933.29998779296875, "invlev_up": 930.79998779296875, "invlev_dn": 930.79998779296875, "manhole_up": "manhole_180_generated", "manhole_dn": "manhole_181_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387742.459816947113723, 5855717.213657722808421 ], [ 1387692.500367184402421, 5855718.495403698645532 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1064", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 933.29998779296875, "elevtn_dn": 911.10003662109375, "invlev_up": 930.79998779296875, "invlev_dn": 908.60003662109375, "manhole_up": "manhole_181_generated", "manhole_dn": "manhole_182_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387692.500367184402421, 5855718.495403698645532 ], [ 1387642.500798417022452, 5855718.61967874225229 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1065", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 911.10003662109375, "elevtn_dn": 887.70001220703125, "invlev_up": 908.60003662109375, "invlev_dn": 885.20001220703125, "manhole_up": "manhole_182_generated", "manhole_dn": "manhole_183_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387642.500798417022452, 5855718.61967874225229 ], [ 1387592.501229649642482, 5855718.743953784927726 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1066", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 887.70001220703125, "elevtn_dn": 887.70001220703125, "invlev_up": 885.20001220703125, "invlev_dn": 885.20001220703125, "manhole_up": "manhole_183_generated", "manhole_dn": "manhole_184_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387592.501229649642482, 5855718.743953784927726 ], [ 1387542.501660882262513, 5855718.868228827603161 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1067", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 887.70001220703125, "elevtn_dn": 902.9000244140625, "invlev_up": 885.20001220703125, "invlev_dn": 900.4000244140625, "manhole_up": "manhole_184_generated", "manhole_dn": "manhole_185_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387542.501660882262513, 5855718.868228827603161 ], [ 1387492.651409652316943, 5855720.815255363471806 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1068", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 902.9000244140625, "elevtn_dn": 902.9000244140625, "invlev_up": 900.4000244140625, "invlev_dn": 900.4000244140625, "manhole_up": "manhole_185_generated", "manhole_dn": "manhole_186_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387492.651409652316943, 5855720.815255363471806 ], [ 1387448.867236748570576, 5855742.752516686916351 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1069", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 902.9000244140625, "elevtn_dn": 886.20001220703125, "invlev_up": 900.4000244140625, "invlev_dn": 883.70001220703125, "manhole_up": "manhole_186_generated", "manhole_dn": "manhole_187_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387448.867236748570576, 5855742.752516686916351 ], [ 1387402.432745414320379, 5855761.091833713464439 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1070", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 886.20001220703125, "elevtn_dn": 886.20001220703125, "invlev_up": 883.70001220703125, "invlev_dn": 883.70001220703125, "manhole_up": "manhole_187_generated", "manhole_dn": "manhole_188_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387402.432745414320379, 5855761.091833713464439 ], [ 1387355.687973388005048, 5855778.837216476909816 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1071", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 886.20001220703125, "elevtn_dn": 879.4000244140625, "invlev_up": 883.70001220703125, "invlev_dn": 876.9000244140625, "manhole_up": "manhole_188_generated", "manhole_dn": "manhole_189_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387355.687973388005048, 5855778.837216476909816 ], [ 1387308.943201361689717, 5855796.582599240355194 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1072", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 879.4000244140625, "elevtn_dn": 879.4000244140625, "invlev_up": 876.9000244140625, "invlev_dn": 876.9000244140625, "manhole_up": "manhole_189_generated", "manhole_dn": "manhole_190_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387308.943201361689717, 5855796.582599240355194 ], [ 1387262.861613623332232, 5855815.656713440082967 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1073", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 879.4000244140625, "elevtn_dn": 873.29998779296875, "invlev_up": 876.9000244140625, "invlev_dn": 870.79998779296875, "manhole_up": "manhole_190_generated", "manhole_dn": "manhole_191_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387262.861613623332232, 5855815.656713440082967 ], [ 1387224.059019178850576, 5855846.996291697025299 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1074", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 873.29998779296875, "elevtn_dn": 938.9000244140625, "invlev_up": 870.79998779296875, "invlev_dn": 936.4000244140625, "manhole_up": "manhole_191_generated", "manhole_dn": "manhole_192_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387224.059019178850576, 5855846.996291697025299 ], [ 1387180.719124856637791, 5855870.194651792757213 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1075", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 938.9000244140625, "elevtn_dn": 932.79998779296875, "invlev_up": 936.4000244140625, "invlev_dn": 930.29998779296875, "manhole_up": "manhole_192_generated", "manhole_dn": "manhole_193_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387180.719124856637791, 5855870.194651792757213 ], [ 1387131.003996425773948, 5855874.064550469629467 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1076", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 932.79998779296875, "elevtn_dn": 932.79998779296875, "invlev_up": 930.29998779296875, "invlev_dn": 930.29998779296875, "manhole_up": "manhole_193_generated", "manhole_dn": "manhole_194_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387131.003996425773948, 5855874.064550469629467 ], [ 1387081.098878284916282, 5855871.158613862469792 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1077", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 932.79998779296875, "elevtn_dn": 916.79998779296875, "invlev_up": 930.29998779296875, "invlev_dn": 914.29998779296875, "manhole_up": "manhole_194_generated", "manhole_dn": "manhole_195_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387081.098878284916282, 5855871.158613862469792 ], [ 1387031.198060098802671, 5855868.015261265449226 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1078", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 916.79998779296875, "elevtn_dn": 916.79998779296875, "invlev_up": 914.29998779296875, "invlev_dn": 914.29998779296875, "manhole_up": "manhole_195_generated", "manhole_dn": "manhole_196_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387031.198060098802671, 5855868.015261265449226 ], [ 1386981.297241912456229, 5855864.871908667497337 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1079", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 916.79998779296875, "elevtn_dn": 891.79998779296875, "invlev_up": 914.29998779296875, "invlev_dn": 889.29998779296875, "manhole_up": "manhole_196_generated", "manhole_dn": "manhole_197_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386981.297241912456229, 5855864.871908667497337 ], [ 1386931.47147326474078, 5855860.718019699677825 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1080", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 891.79998779296875, "elevtn_dn": 891.79998779296875, "invlev_up": 889.29998779296875, "invlev_dn": 889.29998779296875, "manhole_up": "manhole_197_generated", "manhole_dn": "manhole_198_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386931.47147326474078, 5855860.718019699677825 ], [ 1386881.600663758814335, 5855857.577047945931554 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1081", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 891.79998779296875, "elevtn_dn": 857.10003662109375, "invlev_up": 889.29998779296875, "invlev_dn": 854.60003662109375, "manhole_up": "manhole_198_generated", "manhole_dn": "manhole_199_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386881.600663758814335, 5855857.577047945931554 ], [ 1386832.545593914575875, 5855864.100992278195918 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1082", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 857.10003662109375, "elevtn_dn": 857.10003662109375, "invlev_up": 854.60003662109375, "invlev_dn": 854.60003662109375, "manhole_up": "manhole_199_generated", "manhole_dn": "manhole_200_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386832.545593914575875, 5855864.100992278195918 ], [ 1386787.06764860637486, 5855884.403254445642233 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1083", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 857.10003662109375, "elevtn_dn": 821.29998779296875, "invlev_up": 854.60003662109375, "invlev_dn": 818.79998779296875, "manhole_up": "manhole_200_generated", "manhole_dn": "manhole_201_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386787.06764860637486, 5855884.403254445642233 ], [ 1386748.278358669718727, 5855915.544586268253624 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1084", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 821.29998779296875, "elevtn_dn": 821.29998779296875, "invlev_up": 818.79998779296875, "invlev_dn": 818.79998779296875, "manhole_up": "manhole_201_generated", "manhole_dn": "manhole_202_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386748.278358669718727, 5855915.544586268253624 ], [ 1386721.155419877264649, 5855957.124278785660863 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1085", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 821.29998779296875, "elevtn_dn": 866.0, "invlev_up": 818.79998779296875, "invlev_dn": 863.5, "manhole_up": "manhole_202_generated", "manhole_dn": "manhole_203_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386721.155419877264649, 5855957.124278785660863 ], [ 1386707.750365849817172, 5856004.850832763127983 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1086", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 866.0, "invlev_up": 863.5, "invlev_dn": 863.5, "manhole_up": "manhole_203_generated", "manhole_dn": "manhole_204_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386707.750365849817172, 5856004.850832763127983 ], [ 1386699.832475832896307, 5856054.133603978902102 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1087", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 866.0, "invlev_up": 863.5, "invlev_dn": 863.5, "manhole_up": "manhole_204_generated", "manhole_dn": "manhole_205_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386699.832475832896307, 5856054.133603978902102 ], [ 1386697.095561265014112, 5856103.986880083568394 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1088", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 866.0, "elevtn_dn": 884.79998779296875, "invlev_up": 863.5, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_205_generated", "manhole_dn": "manhole_206_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386697.095561265014112, 5856103.986880083568394 ], [ 1386699.401158998254687, 5856153.933416903018951 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1089", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 884.79998779296875, "invlev_up": 882.29998779296875, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_206_generated", "manhole_dn": "manhole_207_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386699.401158998254687, 5856153.933416903018951 ], [ 1386715.699191288091242, 5856201.197657831013203 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1090", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 884.79998779296875, "invlev_up": 882.29998779296875, "invlev_dn": 882.29998779296875, "manhole_up": "manhole_207_generated", "manhole_dn": "manhole_208_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386715.699191288091242, 5856201.197657831013203 ], [ 1386741.121203816728666, 5856244.100116757676005 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1091", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 884.79998779296875, "elevtn_dn": 915.9000244140625, "invlev_up": 882.29998779296875, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_208_generated", "manhole_dn": "manhole_209_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386741.121203816728666, 5856244.100116757676005 ], [ 1386774.051378605188802, 5856281.577651324681938 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1092", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_209_generated", "manhole_dn": "manhole_210_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386774.051378605188802, 5856281.577651324681938 ], [ 1386811.583791718119755, 5856314.587093180976808 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1093", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 915.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 913.4000244140625, "manhole_up": "manhole_210_generated", "manhole_dn": "manhole_211_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386811.583791718119755, 5856314.587093180976808 ], [ 1386839.378956499742344, 5856356.087350118905306 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1094", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 913.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_211_generated", "manhole_dn": "manhole_212_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386839.378956499742344, 5856356.087350118905306 ], [ 1386855.653891535941511, 5856403.364181768149137 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1095", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_212_generated", "manhole_dn": "manhole_213_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386855.653891535941511, 5856403.364181768149137 ], [ 1386875.714553950354457, 5856449.116945925168693 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1096", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_213_generated", "manhole_dn": "manhole_214_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386875.714553950354457, 5856449.116945925168693 ], [ 1386912.179653002182022, 5856482.939191372133791 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1097", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 909.9000244140625, "invlev_up": 907.4000244140625, "invlev_dn": 907.4000244140625, "manhole_up": "manhole_214_generated", "manhole_dn": "manhole_215_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386912.179653002182022, 5856482.939191372133791 ], [ 1386944.191176384687424, 5856520.270725904032588 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1098", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 909.9000244140625, "elevtn_dn": 911.79998779296875, "invlev_up": 907.4000244140625, "invlev_dn": 909.29998779296875, "manhole_up": "manhole_215_generated", "manhole_dn": "manhole_216_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386944.191176384687424, 5856520.270725904032588 ], [ 1386964.188513180473819, 5856566.025075756013393 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1099", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 911.79998779296875, "elevtn_dn": 911.79998779296875, "invlev_up": 909.29998779296875, "invlev_dn": 909.29998779296875, "manhole_up": "manhole_216_generated", "manhole_dn": "manhole_217_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386964.188513180473819, 5856566.025075756013393 ], [ 1386998.825215350603685, 5856599.261941562406719 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1100", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 911.79998779296875, "elevtn_dn": 932.0, "invlev_up": 909.29998779296875, "invlev_dn": 929.5, "manhole_up": "manhole_217_generated", "manhole_dn": "manhole_218_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386998.825215350603685, 5856599.261941562406719 ], [ 1387044.828526843106374, 5856618.849377661012113 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1101", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 932.0, "invlev_up": 929.5, "invlev_dn": 929.5, "manhole_up": "manhole_218_generated", "manhole_dn": "manhole_219_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387044.828526843106374, 5856618.849377661012113 ], [ 1387090.831838335609064, 5856638.43681376054883 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1102", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 949.9000244140625, "invlev_up": 929.5, "invlev_dn": 947.4000244140625, "manhole_up": "manhole_219_generated", "manhole_dn": "manhole_220_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387090.831838335609064, 5856638.43681376054883 ], [ 1387136.835149827878922, 5856658.024249859154224 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1103", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 949.9000244140625, "elevtn_dn": 924.4000244140625, "invlev_up": 947.4000244140625, "invlev_dn": 921.9000244140625, "manhole_up": "manhole_220_generated", "manhole_dn": "manhole_221_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387136.835149827878922, 5856658.024249859154224 ], [ 1387178.671980312326923, 5856685.128790453076363 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1104", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 924.4000244140625, "elevtn_dn": 924.4000244140625, "invlev_up": 921.9000244140625, "invlev_dn": 921.9000244140625, "manhole_up": "manhole_221_generated", "manhole_dn": "manhole_222_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387178.671980312326923, 5856685.128790453076363 ], [ 1387217.700535611249506, 5856716.320352808572352 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1105", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 924.4000244140625, "elevtn_dn": 940.0, "invlev_up": 921.9000244140625, "invlev_dn": 937.5, "manhole_up": "manhole_222_generated", "manhole_dn": "manhole_223_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387217.700535611249506, 5856716.320352808572352 ], [ 1387252.016686553368345, 5856752.649443434551358 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1106", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 940.0, "elevtn_dn": 940.0, "invlev_up": 937.5, "invlev_dn": 937.5, "manhole_up": "manhole_223_generated", "manhole_dn": "manhole_224_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387252.016686553368345, 5856752.649443434551358 ], [ 1387284.798919493798167, 5856790.190159549936652 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1107", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 940.0, "elevtn_dn": 894.29998779296875, "invlev_up": 937.5, "invlev_dn": 891.79998779296875, "manhole_up": "manhole_224_generated", "manhole_dn": "manhole_225_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387284.798919493798167, 5856790.190159549936652 ], [ 1387273.050185391213745, 5856831.931571422144771 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1108", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 894.29998779296875, "elevtn_dn": 891.5, "invlev_up": 891.79998779296875, "invlev_dn": 889.0, "manhole_up": "manhole_225_generated", "manhole_dn": "manhole_226_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387273.050185391213745, 5856831.931571422144771 ], [ 1387226.106990416301414, 5856849.145192969590425 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1109", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 891.5, "elevtn_dn": 891.5, "invlev_up": 889.0, "invlev_dn": 889.0, "manhole_up": "manhole_226_generated", "manhole_dn": "manhole_227_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387226.106990416301414, 5856849.145192969590425 ], [ 1387179.163795441389084, 5856866.358814516104758 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1110", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 891.5, "elevtn_dn": 881.0, "invlev_up": 889.0, "invlev_dn": 878.5, "manhole_up": "manhole_227_generated", "manhole_dn": "manhole_228_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387179.163795441389084, 5856866.358814516104758 ], [ 1387132.220600466709584, 5856883.572436063550413 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1111", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_228_generated", "manhole_dn": "manhole_229_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387132.220600466709584, 5856883.572436063550413 ], [ 1387091.513159692520276, 5856911.129930667579174 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1112", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_229_generated", "manhole_dn": "manhole_230_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387091.513159692520276, 5856911.129930667579174 ], [ 1387071.007118243258446, 5856956.15559543017298 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1113", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 881.0, "invlev_up": 878.5, "invlev_dn": 878.5, "manhole_up": "manhole_230_generated", "manhole_dn": "manhole_231_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387071.007118243258446, 5856956.15559543017298 ], [ 1387043.749112035380676, 5856996.689189162105322 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1114", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 881.0, "elevtn_dn": 856.5, "invlev_up": 878.5, "invlev_dn": 854.0, "manhole_up": "manhole_231_generated", "manhole_dn": "manhole_232_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387043.749112035380676, 5856996.689189162105322 ], [ 1387004.639443967491388, 5857027.840532388538122 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1115", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_232_generated", "manhole_dn": "manhole_233_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387004.639443967491388, 5857027.840532388538122 ], [ 1386965.529775899834931, 5857058.991875615902245 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1116", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_233_generated", "manhole_dn": "manhole_234_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386965.529775899834931, 5857058.991875615902245 ], [ 1386926.702535050921142, 5857090.440239730291069 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1117", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_234_generated", "manhole_dn": "manhole_235_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386926.702535050921142, 5857090.440239730291069 ], [ 1386899.700979894958436, 5857131.871505072340369 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1118", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 856.5, "invlev_up": 854.0, "invlev_dn": 854.0, "manhole_up": "manhole_235_generated", "manhole_dn": "manhole_236_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386899.700979894958436, 5857131.871505072340369 ], [ 1386903.6263940166682, 5857181.005935152061284 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1119", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 856.5, "elevtn_dn": 867.29998779296875, "invlev_up": 854.0, "invlev_dn": 864.79998779296875, "manhole_up": "manhole_236_generated", "manhole_dn": "manhole_237_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386903.6263940166682, 5857181.005935152061284 ], [ 1386920.841401966754347, 5857227.85734468139708 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1120", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 867.29998779296875, "elevtn_dn": 867.29998779296875, "invlev_up": 864.79998779296875, "invlev_dn": 864.79998779296875, "manhole_up": "manhole_237_generated", "manhole_dn": "manhole_238_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386920.841401966754347, 5857227.85734468139708 ], [ 1386940.647245415020734, 5857273.767048302106559 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1121", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 867.29998779296875, "elevtn_dn": 879.0, "invlev_up": 864.79998779296875, "invlev_dn": 876.5, "manhole_up": "manhole_238_generated", "manhole_dn": "manhole_239_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386940.647245415020734, 5857273.767048302106559 ], [ 1386960.453088863519952, 5857319.676751921884716 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1122", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 879.0, "elevtn_dn": 884.5, "invlev_up": 876.5, "invlev_dn": 882.0, "manhole_up": "manhole_239_generated", "manhole_dn": "manhole_240_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386960.453088863519952, 5857319.676751921884716 ], [ 1386980.258932311786339, 5857365.586455542594194 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1123", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 884.5, "invlev_up": 882.0, "invlev_dn": 882.0, "manhole_up": "manhole_240_generated", "manhole_dn": "manhole_241_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386980.258932311786339, 5857365.586455542594194 ], [ 1387000.064775760285556, 5857411.496159162372351 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1124", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 884.5, "invlev_up": 882.0, "invlev_dn": 882.0, "manhole_up": "manhole_241_generated", "manhole_dn": "manhole_242_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387000.064775760285556, 5857411.496159162372351 ], [ 1387007.528902114601806, 5857459.537025099620223 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1125", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 884.5, "elevtn_dn": 893.20001220703125, "invlev_up": 882.0, "invlev_dn": 890.70001220703125, "manhole_up": "manhole_242_generated", "manhole_dn": "manhole_243_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387007.528902114601806, 5857459.537025099620223 ], [ 1386963.21676475298591, 5857476.629049208015203 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1126", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 893.20001220703125, "elevtn_dn": 893.70001220703125, "invlev_up": 890.70001220703125, "invlev_dn": 891.20001220703125, "manhole_up": "manhole_243_generated", "manhole_dn": "manhole_244_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386963.21676475298591, 5857476.629049208015203 ], [ 1386913.783934087026864, 5857484.135433598421514 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1127", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 893.70001220703125, "elevtn_dn": 893.70001220703125, "invlev_up": 891.20001220703125, "invlev_dn": 891.20001220703125, "manhole_up": "manhole_244_generated", "manhole_dn": "manhole_245_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386913.783934087026864, 5857484.135433598421514 ], [ 1386870.539328352315351, 5857507.055611960589886 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1128", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 893.70001220703125, "elevtn_dn": 889.70001220703125, "invlev_up": 891.20001220703125, "invlev_dn": 887.20001220703125, "manhole_up": "manhole_245_generated", "manhole_dn": "manhole_246_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386870.539328352315351, 5857507.055611960589886 ], [ 1386832.820274166297168, 5857539.877026806585491 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1129", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 889.70001220703125, "elevtn_dn": 889.70001220703125, "invlev_up": 887.20001220703125, "invlev_dn": 887.20001220703125, "manhole_up": "manhole_246_generated", "manhole_dn": "manhole_247_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386832.820274166297168, 5857539.877026806585491 ], [ 1386795.101531907683238, 5857572.698800123296678 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1130", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 889.70001220703125, "elevtn_dn": 872.4000244140625, "invlev_up": 887.20001220703125, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_247_generated", "manhole_dn": "manhole_248_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386795.101531907683238, 5857572.698800123296678 ], [ 1386758.257366374600679, 5857606.496797049418092 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1131", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 872.4000244140625, "invlev_up": 869.9000244140625, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_248_generated", "manhole_dn": "manhole_249_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386758.257366374600679, 5857606.496797049418092 ], [ 1386721.502390186069533, 5857640.394349270500243 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1132", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 872.4000244140625, "invlev_up": 869.9000244140625, "invlev_dn": 869.9000244140625, "manhole_up": "manhole_249_generated", "manhole_dn": "manhole_250_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386721.502390186069533, 5857640.394349270500243 ], [ 1386691.639095245627686, 5857680.292891399934888 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1133", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 872.4000244140625, "elevtn_dn": 860.70001220703125, "invlev_up": 869.9000244140625, "invlev_dn": 858.20001220703125, "manhole_up": "manhole_250_generated", "manhole_dn": "manhole_251_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386691.639095245627686, 5857680.292891399934888 ], [ 1386663.127201205352321, 5857721.366519738920033 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1134", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 860.70001220703125, "elevtn_dn": 864.10003662109375, "invlev_up": 858.20001220703125, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_251_generated", "manhole_dn": "manhole_252_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386663.127201205352321, 5857721.366519738920033 ], [ 1386634.70784462057054, 5857762.504245642572641 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1135", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 864.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_252_generated", "manhole_dn": "manhole_253_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386634.70784462057054, 5857762.504245642572641 ], [ 1386606.28848803602159, 5857803.64197154622525 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1136", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 864.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 861.60003662109375, "manhole_up": "manhole_253_generated", "manhole_dn": "manhole_254_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386606.28848803602159, 5857803.64197154622525 ], [ 1386577.851668093586341, 5857844.766917760483921 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1137", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 864.10003662109375, "elevtn_dn": 836.10003662109375, "invlev_up": 861.60003662109375, "invlev_dn": 833.60003662109375, "manhole_up": "manhole_254_generated", "manhole_dn": "manhole_255_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386577.851668093586341, 5857844.766917760483921 ], [ 1386559.479123871540651, 5857890.340473555959761 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1138", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 836.10003662109375, "elevtn_dn": 836.10003662109375, "invlev_up": 833.60003662109375, "invlev_dn": 833.60003662109375, "manhole_up": "manhole_255_generated", "manhole_dn": "manhole_256_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386559.479123871540651, 5857890.340473555959761 ], [ 1386576.858566463226452, 5857935.633445805869997 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1139", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 836.10003662109375, "elevtn_dn": 854.9000244140625, "invlev_up": 833.60003662109375, "invlev_dn": 852.4000244140625, "manhole_up": "manhole_256_generated", "manhole_dn": "manhole_257_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386576.858566463226452, 5857935.633445805869997 ], [ 1386619.073707325849682, 5857961.189545376226306 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1140", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 854.9000244140625, "elevtn_dn": 854.9000244140625, "invlev_up": 852.4000244140625, "invlev_dn": 852.4000244140625, "manhole_up": "manhole_257_generated", "manhole_dn": "manhole_258_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386619.073707325849682, 5857961.189545376226306 ], [ 1386664.860782509436831, 5857981.27706332411617 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1141", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 854.9000244140625, "elevtn_dn": 871.60003662109375, "invlev_up": 852.4000244140625, "invlev_dn": 869.10003662109375, "manhole_up": "manhole_258_generated", "manhole_dn": "manhole_259_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386664.860782509436831, 5857981.27706332411617 ], [ 1386710.721602912992239, 5858001.195835201069713 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1142", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 871.60003662109375, "elevtn_dn": 865.10003662109375, "invlev_up": 869.10003662109375, "invlev_dn": 862.60003662109375, "manhole_up": "manhole_259_generated", "manhole_dn": "manhole_260_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386710.721602912992239, 5858001.195835201069713 ], [ 1386756.582423316547647, 5858021.114607078954577 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1143", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 865.10003662109375, "elevtn_dn": 864.70001220703125, "invlev_up": 862.60003662109375, "invlev_dn": 862.20001220703125, "manhole_up": "manhole_260_generated", "manhole_dn": "manhole_261_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386756.582423316547647, 5858021.114607078954577 ], [ 1386802.443243720103055, 5858041.033378956839442 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1144", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 864.70001220703125, "elevtn_dn": 864.70001220703125, "invlev_up": 862.20001220703125, "invlev_dn": 862.20001220703125, "manhole_up": "manhole_261_generated", "manhole_dn": "manhole_262_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386802.443243720103055, 5858041.033378956839442 ], [ 1386848.304064123658463, 5858060.952150834724307 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1145", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 864.70001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 862.20001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_262_generated", "manhole_dn": "manhole_263_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386848.304064123658463, 5858060.952150834724307 ], [ 1386892.843548113014549, 5858083.471454747952521 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1146", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_263_generated", "manhole_dn": "manhole_264_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386892.843548113014549, 5858083.471454747952521 ], [ 1386931.443847785238177, 5858115.251781782135367 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1147", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 853.60003662109375, "invlev_up": 856.70001220703125, "invlev_dn": 851.10003662109375, "manhole_up": "manhole_264_generated", "manhole_dn": "manhole_265_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386931.443847785238177, 5858115.251781782135367 ], [ 1386970.044147457228974, 5858147.032108817249537 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1148", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 853.60003662109375, "elevtn_dn": 853.60003662109375, "invlev_up": 851.10003662109375, "invlev_dn": 851.10003662109375, "manhole_up": "manhole_265_generated", "manhole_dn": "manhole_266_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386970.044147457228974, 5858147.032108817249537 ], [ 1387008.644447129452601, 5858178.812435851432383 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1149", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 853.60003662109375, "elevtn_dn": 842.4000244140625, "invlev_up": 851.10003662109375, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_266_generated", "manhole_dn": "manhole_267_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387008.644447129452601, 5858178.812435851432383 ], [ 1387047.244746801443398, 5858210.592762886546552 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1150", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 842.4000244140625, "invlev_up": 839.9000244140625, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_267_generated", "manhole_dn": "manhole_268_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387047.244746801443398, 5858210.592762886546552 ], [ 1387085.845046473667026, 5858242.373089920729399 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1151", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 842.4000244140625, "invlev_up": 839.9000244140625, "invlev_dn": 839.9000244140625, "manhole_up": "manhole_268_generated", "manhole_dn": "manhole_269_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387085.845046473667026, 5858242.373089920729399 ], [ 1387124.445346145657822, 5858274.153416955843568 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1152", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 842.4000244140625, "elevtn_dn": 827.60003662109375, "invlev_up": 839.9000244140625, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_269_generated", "manhole_dn": "manhole_270_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387124.445346145657822, 5858274.153416955843568 ], [ 1387163.04564581788145, 5858305.933743990026414 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1153", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_270_generated", "manhole_dn": "manhole_271_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387163.04564581788145, 5858305.933743990026414 ], [ 1387201.829349192325026, 5858337.489215047098696 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1154", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 837.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 835.10003662109375, "manhole_up": "manhole_271_generated", "manhole_dn": "manhole_272_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387201.829349192325026, 5858337.489215047098696 ], [ 1387246.200623227981851, 5858359.687651782296598 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1155", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 837.60003662109375, "elevtn_dn": 837.60003662109375, "invlev_up": 835.10003662109375, "invlev_dn": 835.10003662109375, "manhole_up": "manhole_272_generated", "manhole_dn": "manhole_273_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387246.200623227981851, 5858359.687651782296598 ], [ 1387293.201938283629715, 5858376.741938757710159 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1156", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 837.60003662109375, "elevtn_dn": 843.79998779296875, "invlev_up": 835.10003662109375, "invlev_dn": 841.29998779296875, "manhole_up": "manhole_273_generated", "manhole_dn": "manhole_274_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387293.201938283629715, 5858376.741938757710159 ], [ 1387334.200528149493039, 5858401.732468435540795 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1157", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 843.79998779296875, "elevtn_dn": 822.60003662109375, "invlev_up": 841.29998779296875, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_274_generated", "manhole_dn": "manhole_275_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387334.200528149493039, 5858401.732468435540795 ], [ 1387307.843875054037198, 5858437.110805934295058 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1158", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 822.60003662109375, "invlev_up": 820.10003662109375, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_275_generated", "manhole_dn": "manhole_276_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387307.843875054037198, 5858437.110805934295058 ], [ 1387260.279569417703897, 5858425.045736069791019 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1159", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 820.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_276_generated", "manhole_dn": "manhole_277_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387260.279569417703897, 5858425.045736069791019 ], [ 1387211.448235018178821, 5858414.300554806366563 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1160", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 827.60003662109375, "invlev_up": 825.10003662109375, "invlev_dn": 825.10003662109375, "manhole_up": "manhole_277_generated", "manhole_dn": "manhole_278_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387211.448235018178821, 5858414.300554806366563 ], [ 1387162.612191663123667, 5858403.576134512200952 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1161", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.60003662109375, "elevtn_dn": 822.29998779296875, "invlev_up": 825.10003662109375, "invlev_dn": 819.79998779296875, "manhole_up": "manhole_278_generated", "manhole_dn": "manhole_279_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387162.612191663123667, 5858403.576134512200952 ], [ 1387113.700150535441935, 5858393.210482948459685 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1162", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 822.29998779296875, "elevtn_dn": 822.29998779296875, "invlev_up": 819.79998779296875, "invlev_dn": 819.79998779296875, "manhole_up": "manhole_279_generated", "manhole_dn": "manhole_280_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387113.700150535441935, 5858393.210482948459685 ], [ 1387064.993171223672107, 5858381.975642333738506 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1163", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 822.29998779296875, "elevtn_dn": 827.79998779296875, "invlev_up": 819.79998779296875, "invlev_dn": 825.29998779296875, "manhole_up": "manhole_280_generated", "manhole_dn": "manhole_281_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387064.993171223672107, 5858381.975642333738506 ], [ 1387015.796386598376557, 5858376.342007979750633 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1164", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.79998779296875, "elevtn_dn": 827.79998779296875, "invlev_up": 825.29998779296875, "invlev_dn": 825.29998779296875, "manhole_up": "manhole_281_generated", "manhole_dn": "manhole_282_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387015.796386598376557, 5858376.342007979750633 ], [ 1386966.208506174152717, 5858382.746259398758411 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1165", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.79998779296875, "elevtn_dn": 833.9000244140625, "invlev_up": 825.29998779296875, "invlev_dn": 831.4000244140625, "manhole_up": "manhole_282_generated", "manhole_dn": "manhole_283_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386966.208506174152717, 5858382.746259398758411 ], [ 1386916.676812386140227, 5858389.559525708667934 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1166", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 833.9000244140625, "elevtn_dn": 833.9000244140625, "invlev_up": 831.4000244140625, "invlev_dn": 831.4000244140625, "manhole_up": "manhole_283_generated", "manhole_dn": "manhole_284_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386916.676812386140227, 5858389.559525708667934 ], [ 1386867.198860567295924, 5858396.764010772109032 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1167", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 833.9000244140625, "elevtn_dn": 833.20001220703125, "invlev_up": 831.4000244140625, "invlev_dn": 830.70001220703125, "manhole_up": "manhole_284_generated", "manhole_dn": "manhole_285_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386867.198860567295924, 5858396.764010772109032 ], [ 1386820.816385147860274, 5858411.854353901930153 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1168", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 833.20001220703125, "elevtn_dn": 809.60003662109375, "invlev_up": 830.70001220703125, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_285_generated", "manhole_dn": "manhole_286_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386820.816385147860274, 5858411.854353901930153 ], [ 1386841.361234750133008, 5858445.514383808709681 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1169", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 809.79998779296875, "invlev_up": 807.10003662109375, "invlev_dn": 807.29998779296875, "manhole_up": "manhole_286_generated", "manhole_dn": "manhole_287_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386841.361234750133008, 5858445.514383808709681 ], [ 1386890.796275103231892, 5858452.915634987875819 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1170", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.79998779296875, "elevtn_dn": 809.79998779296875, "invlev_up": 807.29998779296875, "invlev_dn": 807.29998779296875, "manhole_up": "manhole_287_generated", "manhole_dn": "manhole_288_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386890.796275103231892, 5858452.915634987875819 ], [ 1386940.277140651131049, 5858460.100081093609333 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1171", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.79998779296875, "elevtn_dn": 805.4000244140625, "invlev_up": 807.29998779296875, "invlev_dn": 802.9000244140625, "manhole_up": "manhole_288_generated", "manhole_dn": "manhole_289_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386940.277140651131049, 5858460.100081093609333 ], [ 1386989.847997799050063, 5858466.483407464809716 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1172", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.4000244140625, "elevtn_dn": 805.4000244140625, "invlev_up": 802.9000244140625, "invlev_dn": 802.9000244140625, "manhole_up": "manhole_289_generated", "manhole_dn": "manhole_290_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386989.847997799050063, 5858466.483407464809716 ], [ 1387039.689648573985323, 5858470.45608530472964 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1173", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.4000244140625, "elevtn_dn": 804.60003662109375, "invlev_up": 802.9000244140625, "invlev_dn": 802.10003662109375, "manhole_up": "manhole_290_generated", "manhole_dn": "manhole_291_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387039.689648573985323, 5858470.45608530472964 ], [ 1387088.843806148739532, 5858479.424946941435337 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1174", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.60003662109375, "elevtn_dn": 809.9000244140625, "invlev_up": 802.10003662109375, "invlev_dn": 807.4000244140625, "manhole_up": "manhole_291_generated", "manhole_dn": "manhole_292_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387088.843806148739532, 5858479.424946941435337 ], [ 1387137.90604472765699, 5858489.061806742101908 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1175", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.9000244140625, "elevtn_dn": 809.9000244140625, "invlev_up": 807.4000244140625, "invlev_dn": 807.4000244140625, "manhole_up": "manhole_292_generated", "manhole_dn": "manhole_293_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387137.90604472765699, 5858489.061806742101908 ], [ 1387186.336529975291342, 5858500.87968063633889 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1176", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.9000244140625, "elevtn_dn": 822.60003662109375, "invlev_up": 807.4000244140625, "invlev_dn": 820.10003662109375, "manhole_up": "manhole_293_generated", "manhole_dn": "manhole_294_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387186.336529975291342, 5858500.87968063633889 ], [ 1387231.661050535272807, 5858521.423059928230941 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1177", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 822.60003662109375, "elevtn_dn": 787.70001220703125, "invlev_up": 820.10003662109375, "invlev_dn": 785.20001220703125, "manhole_up": "manhole_294_generated", "manhole_dn": "manhole_295_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387231.661050535272807, 5858521.423059928230941 ], [ 1387268.120024613803253, 5858555.03504909388721 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1178", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 787.70001220703125, "elevtn_dn": 787.70001220703125, "invlev_up": 785.20001220703125, "invlev_dn": 785.20001220703125, "manhole_up": "manhole_295_generated", "manhole_dn": "manhole_296_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387268.120024613803253, 5858555.03504909388721 ], [ 1387300.917169471969828, 5858592.775208213366568 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1179", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 787.70001220703125, "elevtn_dn": 797.10003662109375, "invlev_up": 785.20001220703125, "invlev_dn": 794.60003662109375, "manhole_up": "manhole_296_generated", "manhole_dn": "manhole_297_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387300.917169471969828, 5858592.775208213366568 ], [ 1387340.521646688459441, 5858622.315198052674532 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1180", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 797.10003662109375, "elevtn_dn": 797.10003662109375, "invlev_up": 794.60003662109375, "invlev_dn": 794.60003662109375, "manhole_up": "manhole_297_generated", "manhole_dn": "manhole_298_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387340.521646688459441, 5858622.315198052674532 ], [ 1387387.476920192595571, 5858639.495844470337033 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1181", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 797.10003662109375, "elevtn_dn": 806.10003662109375, "invlev_up": 794.60003662109375, "invlev_dn": 803.60003662109375, "manhole_up": "manhole_298_generated", "manhole_dn": "manhole_299_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387387.476920192595571, 5858639.495844470337033 ], [ 1387436.116963447071612, 5858650.82861250359565 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1182", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.10003662109375, "elevtn_dn": 806.10003662109375, "invlev_up": 803.60003662109375, "invlev_dn": 803.60003662109375, "manhole_up": "manhole_299_generated", "manhole_dn": "manhole_300_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387436.116963447071612, 5858650.82861250359565 ], [ 1387485.194103535497561, 5858660.261457678861916 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1183", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.10003662109375, "elevtn_dn": 807.70001220703125, "invlev_up": 803.60003662109375, "invlev_dn": 805.20001220703125, "manhole_up": "manhole_300_generated", "manhole_dn": "manhole_301_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387485.194103535497561, 5858660.261457678861916 ], [ 1387533.804190448950976, 5858671.493853995576501 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1184", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.70001220703125, "elevtn_dn": 772.20001220703125, "invlev_up": 805.20001220703125, "invlev_dn": 769.70001220703125, "manhole_up": "manhole_301_generated", "manhole_dn": "manhole_302_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387533.804190448950976, 5858671.493853995576501 ], [ 1387580.2968336828053, 5858689.619015210308135 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1185", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.20001220703125, "elevtn_dn": 778.79998779296875, "invlev_up": 769.70001220703125, "invlev_dn": 776.29998779296875, "manhole_up": "manhole_302_generated", "manhole_dn": "manhole_303_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387580.2968336828053, 5858689.619015210308135 ], [ 1387628.455277157016098, 5858703.062848121859133 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1186", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.79998779296875, "elevtn_dn": 778.79998779296875, "invlev_up": 776.29998779296875, "invlev_dn": 776.29998779296875, "manhole_up": "manhole_303_generated", "manhole_dn": "manhole_304_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387628.455277157016098, 5858703.062848121859133 ], [ 1387677.211432087467983, 5858713.7862489502877 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1187", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.79998779296875, "elevtn_dn": 786.70001220703125, "invlev_up": 776.29998779296875, "invlev_dn": 784.20001220703125, "manhole_up": "manhole_304_generated", "manhole_dn": "manhole_305_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387677.211432087467983, 5858713.7862489502877 ], [ 1387726.995392211945727, 5858712.747126803733408 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1188", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.70001220703125, "elevtn_dn": 786.70001220703125, "invlev_up": 784.20001220703125, "invlev_dn": 784.20001220703125, "manhole_up": "manhole_305_generated", "manhole_dn": "manhole_306_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387726.995392211945727, 5858712.747126803733408 ], [ 1387773.343349169706926, 5858725.014477553777397 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1189", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.70001220703125, "elevtn_dn": 797.70001220703125, "invlev_up": 784.20001220703125, "invlev_dn": 795.20001220703125, "manhole_up": "manhole_306_generated", "manhole_dn": "manhole_307_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387773.343349169706926, 5858725.014477553777397 ], [ 1387806.363672176143155, 5858762.310494473204017 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1190", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 797.70001220703125, "elevtn_dn": 797.70001220703125, "invlev_up": 795.20001220703125, "invlev_dn": 795.20001220703125, "manhole_up": "manhole_307_generated", "manhole_dn": "manhole_308_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387806.363672176143155, 5858762.310494473204017 ], [ 1387799.717027904232964, 5858810.149600365199149 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1191", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 797.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 795.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_308_generated", "manhole_dn": "manhole_309_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387799.717027904232964, 5858810.149600365199149 ], [ 1387771.971139753237367, 5858850.86109375115484 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1192", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_309_generated", "manhole_dn": "manhole_310_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387771.971139753237367, 5858850.86109375115484 ], [ 1387723.07675126590766, 5858854.679317841306329 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1193", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_310_generated", "manhole_dn": "manhole_311_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387723.07675126590766, 5858854.679317841306329 ], [ 1387673.274138238513842, 5858850.996178055182099 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1194", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_311_generated", "manhole_dn": "manhole_312_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387673.274138238513842, 5858850.996178055182099 ], [ 1387624.170362570788711, 5858858.384703231044114 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1195", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_312_generated", "manhole_dn": "manhole_313_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387624.170362570788711, 5858858.384703231044114 ], [ 1387575.715393897145987, 5858857.046076283790171 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1196", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_313_generated", "manhole_dn": "manhole_314_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387575.715393897145987, 5858857.046076283790171 ], [ 1387529.438332577701658, 5858838.116818149574101 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1197", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 752.70001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 750.20001220703125, "manhole_up": "manhole_314_generated", "manhole_dn": "manhole_315_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387529.438332577701658, 5858838.116818149574101 ], [ 1387481.179235466290265, 5858825.222027675248682 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1198", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.70001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 750.20001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_315_generated", "manhole_dn": "manhole_316_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387481.179235466290265, 5858825.222027675248682 ], [ 1387432.215501294471323, 5858815.797906777821481 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1199", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 772.79998779296875, "invlev_up": 774.70001220703125, "invlev_dn": 770.29998779296875, "manhole_up": "manhole_316_generated", "manhole_dn": "manhole_317_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387432.215501294471323, 5858815.797906777821481 ], [ 1387382.431881646160036, 5858811.154251328669488 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1200", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.79998779296875, "elevtn_dn": 747.10003662109375, "invlev_up": 770.29998779296875, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_317_generated", "manhole_dn": "manhole_318_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387382.431881646160036, 5858811.154251328669488 ], [ 1387336.607072548242286, 5858824.075685098767281 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1201", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 747.10003662109375, "invlev_up": 744.60003662109375, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_318_generated", "manhole_dn": "manhole_319_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387336.607072548242286, 5858824.075685098767281 ], [ 1387327.458137275883928, 5858870.88596049696207 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1202", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 747.10003662109375, "invlev_up": 744.60003662109375, "invlev_dn": 744.60003662109375, "manhole_up": "manhole_319_generated", "manhole_dn": "manhole_320_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387327.458137275883928, 5858870.88596049696207 ], [ 1387344.619252334116027, 5858917.848375800997019 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1203", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.10003662109375, "elevtn_dn": 773.70001220703125, "invlev_up": 744.60003662109375, "invlev_dn": 771.20001220703125, "manhole_up": "manhole_320_generated", "manhole_dn": "manhole_321_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387344.619252334116027, 5858917.848375800997019 ], [ 1387358.089983508689329, 5858965.710649829357862 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1204", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 773.70001220703125, "elevtn_dn": 773.70001220703125, "invlev_up": 771.20001220703125, "invlev_dn": 771.20001220703125, "manhole_up": "manhole_321_generated", "manhole_dn": "manhole_322_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387358.089983508689329, 5858965.710649829357862 ], [ 1387329.564612702699378, 5859003.583583393134177 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1205", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 773.70001220703125, "elevtn_dn": 774.29998779296875, "invlev_up": 771.20001220703125, "invlev_dn": 771.79998779296875, "manhole_up": "manhole_322_generated", "manhole_dn": "manhole_323_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387329.564612702699378, 5859003.583583393134177 ], [ 1387285.783744251355529, 5858993.703191691078246 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1206", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 774.29998779296875, "elevtn_dn": 774.29998779296875, "invlev_up": 771.79998779296875, "invlev_dn": 771.79998779296875, "manhole_up": "manhole_323_generated", "manhole_dn": "manhole_324_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387285.783744251355529, 5858993.703191691078246 ], [ 1387248.355973182013258, 5858961.31797497626394 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1207", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 774.29998779296875, "elevtn_dn": 769.4000244140625, "invlev_up": 771.79998779296875, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_324_generated", "manhole_dn": "manhole_325_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387248.355973182013258, 5858961.31797497626394 ], [ 1387199.500433639157563, 5858963.645901591517031 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1208", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 769.4000244140625, "invlev_up": 766.9000244140625, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_325_generated", "manhole_dn": "manhole_326_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387199.500433639157563, 5858963.645901591517031 ], [ 1387151.482699199579656, 5858977.583961015567183 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1209", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 762.60003662109375, "invlev_up": 766.9000244140625, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_326_generated", "manhole_dn": "manhole_327_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387151.482699199579656, 5858977.583961015567183 ], [ 1387103.632611613254994, 5858992.082134889438748 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1210", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 762.60003662109375, "invlev_up": 760.10003662109375, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_327_generated", "manhole_dn": "manhole_328_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387103.632611613254994, 5858992.082134889438748 ], [ 1387055.853339510038495, 5859006.816905959509313 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1211", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 755.79998779296875, "invlev_up": 760.10003662109375, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_328_generated", "manhole_dn": "manhole_329_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387055.853339510038495, 5859006.816905959509313 ], [ 1387008.074067406589165, 5859021.551677029579878 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1212", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_329_generated", "manhole_dn": "manhole_330_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387008.074067406589165, 5859021.551677029579878 ], [ 1386960.294795303372666, 5859036.286448099650443 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1213", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 749.5, "invlev_up": 753.29998779296875, "invlev_dn": 747.0, "manhole_up": "manhole_330_generated", "manhole_dn": "manhole_331_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386960.294795303372666, 5859036.286448099650443 ], [ 1386912.515523200156167, 5859051.021219169721007 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1214", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 749.5, "elevtn_dn": 749.5, "invlev_up": 747.0, "invlev_dn": 747.0, "manhole_up": "manhole_331_generated", "manhole_dn": "manhole_332_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386912.515523200156167, 5859051.021219169721007 ], [ 1386864.736251096706837, 5859065.755990239791572 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1215", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 749.5, "elevtn_dn": 727.10003662109375, "invlev_up": 747.0, "invlev_dn": 724.60003662109375, "manhole_up": "manhole_332_generated", "manhole_dn": "manhole_333_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386864.736251096706837, 5859065.755990239791572 ], [ 1386816.956978993490338, 5859080.490761309862137 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1216", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 727.10003662109375, "elevtn_dn": 752.29998779296875, "invlev_up": 724.60003662109375, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_333_generated", "manhole_dn": "manhole_334_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386816.956978993490338, 5859080.490761309862137 ], [ 1386769.832018451532349, 5859096.976014334708452 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1217", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 738.0, "invlev_up": 749.79998779296875, "invlev_dn": 735.5, "manhole_up": "manhole_334_generated", "manhole_dn": "manhole_335_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386769.832018451532349, 5859096.976014334708452 ], [ 1386724.102282747160643, 5859117.193917133845389 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1218", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 738.0, "invlev_up": 735.5, "invlev_dn": 735.5, "manhole_up": "manhole_335_generated", "manhole_dn": "manhole_336_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386724.102282747160643, 5859117.193917133845389 ], [ 1386678.372547042788938, 5859137.411819933913648 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1219", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 732.79998779296875, "invlev_up": 735.5, "invlev_dn": 730.29998779296875, "manhole_up": "manhole_336_generated", "manhole_dn": "manhole_337_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386678.372547042788938, 5859137.411819933913648 ], [ 1386632.642811338417232, 5859157.629722733050585 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1220", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.79998779296875, "elevtn_dn": 732.79998779296875, "invlev_up": 730.29998779296875, "invlev_dn": 730.29998779296875, "manhole_up": "manhole_337_generated", "manhole_dn": "manhole_338_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386632.642811338417232, 5859157.629722733050585 ], [ 1386586.913075634045526, 5859177.847625533118844 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1221", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.79998779296875, "elevtn_dn": 732.60003662109375, "invlev_up": 730.29998779296875, "invlev_dn": 730.10003662109375, "manhole_up": "manhole_338_generated", "manhole_dn": "manhole_339_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386586.913075634045526, 5859177.847625533118844 ], [ 1386541.181931287748739, 5859198.062337793409824 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1222", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.60003662109375, "elevtn_dn": 732.60003662109375, "invlev_up": 730.10003662109375, "invlev_dn": 730.10003662109375, "manhole_up": "manhole_339_generated", "manhole_dn": "manhole_340_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386541.181931287748739, 5859198.062337793409824 ], [ 1386495.431538854492828, 5859218.233453613705933 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1223", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.60003662109375, "elevtn_dn": 742.5, "invlev_up": 730.10003662109375, "invlev_dn": 740.0, "manhole_up": "manhole_340_generated", "manhole_dn": "manhole_341_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386495.431538854492828, 5859218.233453613705933 ], [ 1386449.681146421469748, 5859238.404569433070719 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1224", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 742.5, "invlev_up": 740.0, "invlev_dn": 740.0, "manhole_up": "manhole_341_generated", "manhole_dn": "manhole_342_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386449.681146421469748, 5859238.404569433070719 ], [ 1386404.749107032548636, 5859260.314221715554595 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1225", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 717.60003662109375, "invlev_up": 740.0, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_342_generated", "manhole_dn": "manhole_343_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386404.749107032548636, 5859260.314221715554595 ], [ 1386360.756595908896998, 5859284.020064728334546 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1226", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 717.60003662109375, "invlev_up": 715.10003662109375, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_343_generated", "manhole_dn": "manhole_344_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386360.756595908896998, 5859284.020064728334546 ], [ 1386317.622744857333601, 5859309.307279178872705 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1227", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 711.0, "invlev_up": 715.10003662109375, "invlev_dn": 708.5, "manhole_up": "manhole_344_generated", "manhole_dn": "manhole_345_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386317.622744857333601, 5859309.307279178872705 ], [ 1386274.488893805770203, 5859334.594493629410863 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1228", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 711.0, "elevtn_dn": 717.60003662109375, "invlev_up": 708.5, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_345_generated", "manhole_dn": "manhole_346_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386274.488893805770203, 5859334.594493629410863 ], [ 1386231.354723542230204, 5859359.881163572892547 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1229", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 739.0, "invlev_up": 715.10003662109375, "invlev_dn": 736.5, "manhole_up": "manhole_346_generated", "manhole_dn": "manhole_347_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386231.354723542230204, 5859359.881163572892547 ], [ 1386188.788941488368437, 5859385.978958465158939 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1230", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 739.0, "invlev_up": 736.5, "invlev_dn": 736.5, "manhole_up": "manhole_347_generated", "manhole_dn": "manhole_348_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386188.788941488368437, 5859385.978958465158939 ], [ 1386153.170269979629666, 5859420.751348914578557 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1231", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 739.0, "invlev_up": 736.5, "invlev_dn": 736.5, "manhole_up": "manhole_348_generated", "manhole_dn": "manhole_349_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386153.170269979629666, 5859420.751348914578557 ], [ 1386127.241226618411019, 5859463.08446778729558 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1232", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 770.60003662109375, "invlev_up": 736.5, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_349_generated", "manhole_dn": "manhole_350_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386127.241226618411019, 5859463.08446778729558 ], [ 1386108.996456971857697, 5859509.052053713239729 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1233", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_350_generated", "manhole_dn": "manhole_351_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386108.996456971857697, 5859509.052053713239729 ], [ 1386105.954033384332433, 5859558.959127158857882 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1234", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_351_generated", "manhole_dn": "manhole_352_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386105.954033384332433, 5859558.959127158857882 ], [ 1386101.917093347059563, 5859608.782215913757682 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1235", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 779.79998779296875, "invlev_up": 768.10003662109375, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_352_generated", "manhole_dn": "manhole_353_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386101.917093347059563, 5859608.782215913757682 ], [ 1386088.458339030388743, 5859656.652665913105011 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1236", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 779.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_353_generated", "manhole_dn": "manhole_354_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386088.458339030388743, 5859656.652665913105011 ], [ 1386075.652030121767893, 5859704.419184413738549 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1237", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 779.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_354_generated", "manhole_dn": "manhole_355_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386075.652030121767893, 5859704.419184413738549 ], [ 1386076.574770522769541, 5859754.410392354242504 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1238", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_355_generated", "manhole_dn": "manhole_356_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386076.574770522769541, 5859754.410392354242504 ], [ 1386077.497510923538357, 5859804.401600294746459 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_9_E1239", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_9", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_9", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_356_generated", "manhole_dn": "manhole_357_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386077.497510923538357, 5859804.401600294746459 ], [ 1386078.420251324307173, 5859854.392808235250413 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E195", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 814.29998779296875, "elevtn_dn": 802.9000244140625, "invlev_up": 811.79998779296875, "invlev_dn": 800.4000244140625, "manhole_up": "manhole_358_generated", "manhole_dn": "manhole_359_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384050.267680946970358, 5856698.702001548372209 ], [ 1384085.778961833100766, 5856733.441067186184227 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E196", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 802.9000244140625, "elevtn_dn": 802.9000244140625, "invlev_up": 800.4000244140625, "invlev_dn": 800.4000244140625, "manhole_up": "manhole_359_generated", "manhole_dn": "manhole_360_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384085.778961833100766, 5856733.441067186184227 ], [ 1384122.993944165529683, 5856766.592179889790714 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E197", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 802.9000244140625, "elevtn_dn": 816.29998779296875, "invlev_up": 800.4000244140625, "invlev_dn": 813.79998779296875, "manhole_up": "manhole_360_generated", "manhole_dn": "manhole_361_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384122.993944165529683, 5856766.592179889790714 ], [ 1384160.350959801580757, 5856799.578122235834599 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E198", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.29998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 813.79998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_361_generated", "manhole_dn": "manhole_362_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384160.350959801580757, 5856799.578122235834599 ], [ 1384198.384374253917485, 5856831.724873264320195 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E199", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 798.29998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_362_generated", "manhole_dn": "manhole_363_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384198.384374253917485, 5856831.724873264320195 ], [ 1384230.112839305773377, 5856870.159957353956997 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E200", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 793.9000244140625, "invlev_up": 798.29998779296875, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_363_generated", "manhole_dn": "manhole_364_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384230.112839305773377, 5856870.159957353956997 ], [ 1384259.121702386764809, 5856910.628996902145445 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E201", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 807.60003662109375, "invlev_up": 791.4000244140625, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_364_generated", "manhole_dn": "manhole_365_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384259.121702386764809, 5856910.628996902145445 ], [ 1384287.023718592710793, 5856951.925833041779697 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E202", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_365_generated", "manhole_dn": "manhole_366_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384287.023718592710793, 5856951.925833041779697 ], [ 1384314.929269487503916, 5856993.22028074786067 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E203", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_366_generated", "manhole_dn": "manhole_367_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384314.929269487503916, 5856993.22028074786067 ], [ 1384344.819752591196448, 5857033.056208833120763 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E204", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_367_generated", "manhole_dn": "manhole_368_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384344.819752591196448, 5857033.056208833120763 ], [ 1384375.891110281459987, 5857072.024425559677184 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E205", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_368_generated", "manhole_dn": "manhole_369_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384375.891110281459987, 5857072.024425559677184 ], [ 1384412.732155854580924, 5857105.507668288424611 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E206", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_369_generated", "manhole_dn": "manhole_370_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384412.732155854580924, 5857105.507668288424611 ], [ 1384450.07948348694481, 5857138.509612204506993 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E207", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_370_generated", "manhole_dn": "manhole_371_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384450.07948348694481, 5857138.509612204506993 ], [ 1384487.42686335532926, 5857171.511497005820274 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E208", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 805.0, "invlev_up": 793.4000244140625, "invlev_dn": 802.5, "manhole_up": "manhole_371_generated", "manhole_dn": "manhole_372_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384487.42686335532926, 5857171.511497005820274 ], [ 1384525.207759798038751, 5857204.014277670532465 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E209", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 796.29998779296875, "invlev_up": 802.5, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_372_generated", "manhole_dn": "manhole_373_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384525.207759798038751, 5857204.014277670532465 ], [ 1384563.111988977529109, 5857236.375065575353801 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E210", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 796.29998779296875, "invlev_up": 793.79998779296875, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_373_generated", "manhole_dn": "manhole_374_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384563.111988977529109, 5857236.375065575353801 ], [ 1384601.016218156786636, 5857268.735853480175138 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E211", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 786.10003662109375, "invlev_up": 793.79998779296875, "invlev_dn": 783.60003662109375, "manhole_up": "manhole_374_generated", "manhole_dn": "manhole_375_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384601.016218156786636, 5857268.735853480175138 ], [ 1384638.920447336044163, 5857301.096641384996474 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E212", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.10003662109375, "elevtn_dn": 794.29998779296875, "invlev_up": 783.60003662109375, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_375_generated", "manhole_dn": "manhole_376_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384638.920447336044163, 5857301.096641384996474 ], [ 1384669.604954990325496, 5857340.313404724933207 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E213", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 794.29998779296875, "invlev_up": 791.79998779296875, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_376_generated", "manhole_dn": "manhole_377_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384669.604954990325496, 5857340.313404724933207 ], [ 1384699.518247769214213, 5857380.104403200559318 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E214", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 794.29998779296875, "invlev_up": 791.79998779296875, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_377_generated", "manhole_dn": "manhole_378_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384699.518247769214213, 5857380.104403200559318 ], [ 1384719.806332413339987, 5857425.627417215146124 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E215", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 782.0, "invlev_up": 791.79998779296875, "invlev_dn": 779.5, "manhole_up": "manhole_378_generated", "manhole_dn": "manhole_379_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384719.806332413339987, 5857425.627417215146124 ], [ 1384740.094417057465762, 5857471.150431229732931 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E216", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 782.0, "elevtn_dn": 789.70001220703125, "invlev_up": 779.5, "invlev_dn": 787.20001220703125, "manhole_up": "manhole_379_generated", "manhole_dn": "manhole_380_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384740.094417057465762, 5857471.150431229732931 ], [ 1384760.382501701591536, 5857516.673445244319737 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E217", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 789.70001220703125, "elevtn_dn": 789.70001220703125, "invlev_up": 787.20001220703125, "invlev_dn": 787.20001220703125, "manhole_up": "manhole_380_generated", "manhole_dn": "manhole_381_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384760.382501701591536, 5857516.673445244319737 ], [ 1384780.670586345717311, 5857562.196459258906543 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E218", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 789.70001220703125, "elevtn_dn": 796.5, "invlev_up": 787.20001220703125, "invlev_dn": 794.0, "manhole_up": "manhole_381_generated", "manhole_dn": "manhole_382_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384780.670586345717311, 5857562.196459258906543 ], [ 1384802.672203443944454, 5857606.838341221213341 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E219", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 796.5, "elevtn_dn": 771.9000244140625, "invlev_up": 794.0, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_382_generated", "manhole_dn": "manhole_383_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384802.672203443944454, 5857606.838341221213341 ], [ 1384827.896526007680222, 5857649.823044718243182 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E220", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_383_generated", "manhole_dn": "manhole_384_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384827.896526007680222, 5857649.823044718243182 ], [ 1384854.757882944308221, 5857691.606820800341666 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E221", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_384_generated", "manhole_dn": "manhole_385_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384854.757882944308221, 5857691.606820800341666 ], [ 1384888.185768931638449, 5857728.573395187035203 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E222", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_385_generated", "manhole_dn": "manhole_386_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384888.185768931638449, 5857728.573395187035203 ], [ 1384921.613654918735847, 5857765.539969574660063 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E223", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 755.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_386_generated", "manhole_dn": "manhole_387_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384921.613654918735847, 5857765.539969574660063 ], [ 1384956.145453942706808, 5857801.445756647735834 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E224", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 757.9000244140625, "invlev_up": 755.4000244140625, "invlev_dn": 755.4000244140625, "manhole_up": "manhole_387_generated", "manhole_dn": "manhole_388_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384956.145453942706808, 5857801.445756647735834 ], [ 1384991.751306539867073, 5857836.319449373520911 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E225", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 757.9000244140625, "elevtn_dn": 746.0, "invlev_up": 755.4000244140625, "invlev_dn": 743.5, "manhole_up": "manhole_388_generated", "manhole_dn": "manhole_389_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384991.751306539867073, 5857836.319449373520911 ], [ 1385027.357159137027338, 5857871.193142099305987 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E226", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 746.0, "elevtn_dn": 755.79998779296875, "invlev_up": 743.5, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_389_generated", "manhole_dn": "manhole_390_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385027.357159137027338, 5857871.193142099305987 ], [ 1385062.963011734187603, 5857906.066834825091064 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E227", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 728.60003662109375, "invlev_up": 753.29998779296875, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_390_generated", "manhole_dn": "manhole_391_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385062.963011734187603, 5857906.066834825091064 ], [ 1385098.568864331347868, 5857940.940527551807463 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E228", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 728.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_391_generated", "manhole_dn": "manhole_392_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385098.568864331347868, 5857940.940527551807463 ], [ 1385135.753846400883049, 5857974.029479116201401 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E229", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 728.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 726.10003662109375, "manhole_up": "manhole_392_generated", "manhole_dn": "manhole_393_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385135.753846400883049, 5857974.029479116201401 ], [ 1385175.738456205930561, 5858003.622975903563201 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E230", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 728.60003662109375, "elevtn_dn": 735.60003662109375, "invlev_up": 726.10003662109375, "invlev_dn": 733.10003662109375, "manhole_up": "manhole_393_generated", "manhole_dn": "manhole_394_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385175.738456205930561, 5858003.622975903563201 ], [ 1385218.653756857383996, 5858028.965196672827005 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E231", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 735.60003662109375, "elevtn_dn": 735.60003662109375, "invlev_up": 733.10003662109375, "invlev_dn": 733.10003662109375, "manhole_up": "manhole_394_generated", "manhole_dn": "manhole_395_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385218.653756857383996, 5858028.965196672827005 ], [ 1385262.454936756985262, 5858052.706982978619635 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E232", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 735.60003662109375, "elevtn_dn": 742.0, "invlev_up": 733.10003662109375, "invlev_dn": 739.5, "manhole_up": "manhole_395_generated", "manhole_dn": "manhole_396_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385262.454936756985262, 5858052.706982978619635 ], [ 1385306.715555034345016, 5858075.618745312094688 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E233", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 742.0, "elevtn_dn": 742.0, "invlev_up": 739.5, "invlev_dn": 739.5, "manhole_up": "manhole_396_generated", "manhole_dn": "manhole_397_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385306.715555034345016, 5858075.618745312094688 ], [ 1385350.97617331170477, 5858098.530507644638419 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E234", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 742.0, "elevtn_dn": 736.0, "invlev_up": 739.5, "invlev_dn": 733.5, "manhole_up": "manhole_397_generated", "manhole_dn": "manhole_398_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385350.97617331170477, 5858098.530507644638419 ], [ 1385395.236791589297354, 5858121.442269978113472 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E235", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 736.0, "elevtn_dn": 736.0, "invlev_up": 733.5, "invlev_dn": 733.5, "manhole_up": "manhole_398_generated", "manhole_dn": "manhole_399_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385395.236791589297354, 5858121.442269978113472 ], [ 1385439.497409866657108, 5858144.354032310657203 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E236", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 736.0, "elevtn_dn": 737.9000244140625, "invlev_up": 733.5, "invlev_dn": 735.4000244140625, "manhole_up": "manhole_399_generated", "manhole_dn": "manhole_400_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385439.497409866657108, 5858144.354032310657203 ], [ 1385483.758028144016862, 5858167.265794644132257 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E237", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.9000244140625, "elevtn_dn": 737.9000244140625, "invlev_up": 735.4000244140625, "invlev_dn": 735.4000244140625, "manhole_up": "manhole_400_generated", "manhole_dn": "manhole_401_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385483.758028144016862, 5858167.265794644132257 ], [ 1385528.018646421376616, 5858190.17755697760731 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E238", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.9000244140625, "elevtn_dn": 727.29998779296875, "invlev_up": 735.4000244140625, "invlev_dn": 724.79998779296875, "manhole_up": "manhole_401_generated", "manhole_dn": "manhole_402_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385528.018646421376616, 5858190.17755697760731 ], [ 1385571.606102279853076, 5858214.277655217796564 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E239", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 727.29998779296875, "elevtn_dn": 727.29998779296875, "invlev_up": 724.79998779296875, "invlev_dn": 724.79998779296875, "manhole_up": "manhole_402_generated", "manhole_dn": "manhole_403_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385571.606102279853076, 5858214.277655217796564 ], [ 1385614.013400863157585, 5858240.461089110001922 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E240", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 727.29998779296875, "elevtn_dn": 690.60003662109375, "invlev_up": 724.79998779296875, "invlev_dn": 688.10003662109375, "manhole_up": "manhole_403_generated", "manhole_dn": "manhole_404_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385614.013400863157585, 5858240.461089110001922 ], [ 1385656.420699446462095, 5858266.644523002207279 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E241", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 690.60003662109375, "elevtn_dn": 733.60003662109375, "invlev_up": 688.10003662109375, "invlev_dn": 731.10003662109375, "manhole_up": "manhole_404_generated", "manhole_dn": "manhole_405_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385656.420699446462095, 5858266.644523002207279 ], [ 1385698.773111530812457, 5858292.8961898451671 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E242", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 733.60003662109375, "elevtn_dn": 733.60003662109375, "invlev_up": 731.10003662109375, "invlev_dn": 731.10003662109375, "manhole_up": "manhole_405_generated", "manhole_dn": "manhole_406_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385698.773111530812457, 5858292.8961898451671 ], [ 1385733.435650466475636, 5858328.707634637132287 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E243", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 733.60003662109375, "elevtn_dn": 721.60003662109375, "invlev_up": 731.10003662109375, "invlev_dn": 719.10003662109375, "manhole_up": "manhole_406_generated", "manhole_dn": "manhole_407_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385733.435650466475636, 5858328.707634637132287 ], [ 1385768.098189401905984, 5858364.519079428166151 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E244", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 721.60003662109375, "elevtn_dn": 721.60003662109375, "invlev_up": 719.10003662109375, "invlev_dn": 719.10003662109375, "manhole_up": "manhole_407_generated", "manhole_dn": "manhole_408_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385768.098189401905984, 5858364.519079428166151 ], [ 1385795.882535298354924, 5858405.467093757353723 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E245", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 721.60003662109375, "elevtn_dn": 739.0, "invlev_up": 719.10003662109375, "invlev_dn": 736.5, "manhole_up": "manhole_408_generated", "manhole_dn": "manhole_409_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385795.882535298354924, 5858405.467093757353723 ], [ 1385820.377634756267071, 5858448.871486231684685 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E246", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 739.0, "elevtn_dn": 727.79998779296875, "invlev_up": 736.5, "invlev_dn": 725.29998779296875, "manhole_up": "manhole_409_generated", "manhole_dn": "manhole_410_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385820.377634756267071, 5858448.871486231684685 ], [ 1385841.084314390551299, 5858493.920932004228234 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E247", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 727.79998779296875, "elevtn_dn": 727.79998779296875, "invlev_up": 725.29998779296875, "invlev_dn": 725.29998779296875, "manhole_up": "manhole_410_generated", "manhole_dn": "manhole_411_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385841.084314390551299, 5858493.920932004228234 ], [ 1385856.076261736918241, 5858541.451897682622075 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E248", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 727.79998779296875, "elevtn_dn": 734.9000244140625, "invlev_up": 725.29998779296875, "invlev_dn": 732.4000244140625, "manhole_up": "manhole_411_generated", "manhole_dn": "manhole_412_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385856.076261736918241, 5858541.451897682622075 ], [ 1385865.668899663724005, 5858590.250006795860827 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E249", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 734.9000244140625, "elevtn_dn": 734.9000244140625, "invlev_up": 732.4000244140625, "invlev_dn": 732.4000244140625, "manhole_up": "manhole_412_generated", "manhole_dn": "manhole_413_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385865.668899663724005, 5858590.250006795860827 ], [ 1385873.387286560609937, 5858639.487976770848036 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E250", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 734.9000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 732.4000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_413_generated", "manhole_dn": "manhole_414_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385873.387286560609937, 5858639.487976770848036 ], [ 1385875.017949819331989, 5858689.287253175862134 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E251", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 748.9000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_414_generated", "manhole_dn": "manhole_415_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385875.017949819331989, 5858689.287253175862134 ], [ 1385876.432928551919758, 5858739.106416343711317 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E252", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 748.9000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_415_generated", "manhole_dn": "manhole_416_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385876.432928551919758, 5858739.106416343711317 ], [ 1385878.329821793129668, 5858788.908141564577818 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E253", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 748.9000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_416_generated", "manhole_dn": "manhole_417_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385878.329821793129668, 5858788.908141564577818 ], [ 1385880.51921496167779, 5858838.69928275514394 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E254", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_417_generated", "manhole_dn": "manhole_418_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385880.51921496167779, 5858838.69928275514394 ], [ 1385882.620351102668792, 5858888.493530485779047 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E255", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_418_generated", "manhole_dn": "manhole_419_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385882.620351102668792, 5858888.493530485779047 ], [ 1385883.937443709466606, 5858938.315377607010305 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E256", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 766.10003662109375, "invlev_up": 757.20001220703125, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_419_generated", "manhole_dn": "manhole_420_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385883.937443709466606, 5858938.315377607010305 ], [ 1385885.254538560518995, 5858988.137224668636918 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E257", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 766.10003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_420_generated", "manhole_dn": "manhole_421_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385885.254538560518995, 5858988.137224668636918 ], [ 1385890.650534195825458, 5859037.630400610156357 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E258", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 766.10003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 763.60003662109375, "manhole_up": "manhole_421_generated", "manhole_dn": "manhole_422_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385890.650534195825458, 5859037.630400610156357 ], [ 1385901.777442803606391, 5859086.09239396546036 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E259", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.10003662109375, "elevtn_dn": 768.60003662109375, "invlev_up": 763.60003662109375, "invlev_dn": 766.10003662109375, "manhole_up": "manhole_422_generated", "manhole_dn": "manhole_423_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385901.777442803606391, 5859086.09239396546036 ], [ 1385915.397954803425819, 5859134.03436760418117 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E260", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.60003662109375, "elevtn_dn": 762.79998779296875, "invlev_up": 766.10003662109375, "invlev_dn": 760.29998779296875, "manhole_up": "manhole_423_generated", "manhole_dn": "manhole_424_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385915.397954803425819, 5859134.03436760418117 ], [ 1385928.42605347908102, 5859182.139209139160812 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E261", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.79998779296875, "elevtn_dn": 762.5, "invlev_up": 760.29998779296875, "invlev_dn": 760.0, "manhole_up": "manhole_424_generated", "manhole_dn": "manhole_425_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385928.42605347908102, 5859182.139209139160812 ], [ 1385941.228082312969491, 5859230.306202415376902 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E262", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 762.5, "invlev_up": 760.0, "invlev_dn": 760.0, "manhole_up": "manhole_425_generated", "manhole_dn": "manhole_426_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385941.228082312969491, 5859230.306202415376902 ], [ 1385945.092689140234143, 5859279.734331246465445 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E263", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 762.5, "invlev_up": 760.0, "invlev_dn": 760.0, "manhole_up": "manhole_426_generated", "manhole_dn": "manhole_427_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385945.092689140234143, 5859279.734331246465445 ], [ 1385937.902412303024903, 5859328.779896341264248 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E264", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.5, "elevtn_dn": 778.0, "invlev_up": 760.0, "invlev_dn": 775.5, "manhole_up": "manhole_427_generated", "manhole_dn": "manhole_428_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.902412303024903, 5859328.779896341264248 ], [ 1385932.795075723901391, 5859378.173214216716588 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E265", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 778.0, "invlev_up": 775.5, "invlev_dn": 775.5, "manhole_up": "manhole_428_generated", "manhole_dn": "manhole_429_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385932.795075723901391, 5859378.173214216716588 ], [ 1385937.702695531537756, 5859427.770254967734218 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E266", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 778.0, "invlev_up": 775.5, "invlev_dn": 775.5, "manhole_up": "manhole_429_generated", "manhole_dn": "manhole_430_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.702695531537756, 5859427.770254967734218 ], [ 1385939.035937832202762, 5859477.50230407807976 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E267", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.0, "elevtn_dn": 795.9000244140625, "invlev_up": 775.5, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_430_generated", "manhole_dn": "manhole_431_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385939.035937832202762, 5859477.50230407807976 ], [ 1385937.883638251805678, 5859527.328234969638288 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E268", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_431_generated", "manhole_dn": "manhole_432_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385937.883638251805678, 5859527.328234969638288 ], [ 1385940.515994266141206, 5859576.989168248139322 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E269", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_432_generated", "manhole_dn": "manhole_433_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385940.515994266141206, 5859576.989168248139322 ], [ 1385950.701545101590455, 5859625.530176519416273 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E270", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 815.0, "invlev_up": 793.4000244140625, "invlev_dn": 812.5, "manhole_up": "manhole_433_generated", "manhole_dn": "manhole_434_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385950.701545101590455, 5859625.530176519416273 ], [ 1385970.467743494315073, 5859670.991298755630851 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E271", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 815.0, "elevtn_dn": 815.0, "invlev_up": 812.5, "invlev_dn": 812.5, "manhole_up": "manhole_434_generated", "manhole_dn": "manhole_435_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385970.467743494315073, 5859670.991298755630851 ], [ 1386011.983088220236823, 5859697.862916950136423 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E272", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 815.0, "elevtn_dn": 779.79998779296875, "invlev_up": 812.5, "invlev_dn": 777.29998779296875, "manhole_up": "manhole_435_generated", "manhole_dn": "manhole_436_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386011.983088220236823, 5859697.862916950136423 ], [ 1386052.213596233632416, 5859727.119808158837259 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E273", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 779.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 777.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_436_generated", "manhole_dn": "manhole_437_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386052.213596233632416, 5859727.119808158837259 ], [ 1386046.501012831227854, 5859771.612671964801848 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E274", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_437_generated", "manhole_dn": "manhole_438_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386046.501012831227854, 5859771.612671964801848 ], [ 1386026.809695787727833, 5859816.873920152895153 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E275", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_438_generated", "manhole_dn": "manhole_439_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386026.809695787727833, 5859816.873920152895153 ], [ 1386030.149607364553958, 5859866.379009906202555 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_10_E276", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_10", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_10", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_439_generated", "manhole_dn": "manhole_440_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386030.149607364553958, 5859866.379009906202555 ], [ 1386045.250939248362556, 5859913.859036295674741 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_11_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 800.79998779296875, "invlev_up": 798.29998779296875, "invlev_dn": 798.29998779296875, "manhole_up": "manhole_441_generated", "manhole_dn": "manhole_442_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384196.861816460033879, 5856829.88048410974443 ], [ 1384235.22519311751239, 5856854.977665597572923 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_11_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 800.79998779296875, "elevtn_dn": 793.9000244140625, "invlev_up": 798.29998779296875, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_442_generated", "manhole_dn": "manhole_443_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384235.22519311751239, 5856854.977665597572923 ], [ 1384263.450329831801355, 5856892.038370934315026 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_11_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 793.9000244140625, "invlev_up": 791.4000244140625, "invlev_dn": 791.4000244140625, "manhole_up": "manhole_443_generated", "manhole_dn": "manhole_444_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384263.450329831801355, 5856892.038370934315026 ], [ 1384291.675466545857489, 5856929.099076271057129 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_11_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.9000244140625, "elevtn_dn": 807.60003662109375, "invlev_up": 791.4000244140625, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_444_generated", "manhole_dn": "manhole_445_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384291.675466545857489, 5856929.099076271057129 ], [ 1384319.900603260146454, 5856966.159781608730555 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_11_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_445_generated", "manhole_dn": "manhole_446_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384319.900603260146454, 5856966.159781608730555 ], [ 1384347.205867683747783, 5857003.894510924816132 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_11_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 799.0, "invlev_up": 805.10003662109375, "invlev_dn": 796.5, "manhole_up": "manhole_446_generated", "manhole_dn": "manhole_447_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384347.205867683747783, 5857003.894510924816132 ], [ 1384380.322691001230851, 5857036.360282040201128 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_11_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 799.0, "elevtn_dn": 807.60003662109375, "invlev_up": 796.5, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_447_generated", "manhole_dn": "manhole_448_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384380.322691001230851, 5857036.360282040201128 ], [ 1384415.156610523350537, 5857067.291694445535541 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_11_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_448_generated", "manhole_dn": "manhole_449_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384415.156610523350537, 5857067.291694445535541 ], [ 1384449.343575850594789, 5857098.828100205399096 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_11_E8", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_449_generated", "manhole_dn": "manhole_450_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384449.343575850594789, 5857098.828100205399096 ], [ 1384470.004810179118067, 5857139.926174183376133 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_11_E9", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_11", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_11", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_450_generated", "manhole_dn": "manhole_451_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384470.004810179118067, 5857139.926174183376133 ], [ 1384484.18076178082265, 5857184.301805094815791 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_12_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_452_generated", "manhole_dn": "manhole_453_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384289.06552429520525, 5856954.947841017507017 ], [ 1384305.049610810354352, 5856994.88734863139689 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_12_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_453_generated", "manhole_dn": "manhole_454_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384305.049610810354352, 5856994.88734863139689 ], [ 1384321.033697325503454, 5857034.82685624435544 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_12_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 799.0, "invlev_up": 805.10003662109375, "invlev_dn": 796.5, "manhole_up": "manhole_454_generated", "manhole_dn": "manhole_455_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384321.033697325503454, 5857034.82685624435544 ], [ 1384347.445656489115208, 5857068.672038841992617 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_12_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 799.0, "elevtn_dn": 807.60003662109375, "invlev_up": 796.5, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_455_generated", "manhole_dn": "manhole_456_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384347.445656489115208, 5857068.672038841992617 ], [ 1384374.130628447979689, 5857102.406951548531651 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_12_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_456_generated", "manhole_dn": "manhole_457_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384374.130628447979689, 5857102.406951548531651 ], [ 1384399.587644136510789, 5857137.08541233278811 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_12_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 807.60003662109375, "invlev_up": 805.10003662109375, "invlev_dn": 805.10003662109375, "manhole_up": "manhole_457_generated", "manhole_dn": "manhole_458_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384399.587644136510789, 5857137.08541233278811 ], [ 1384425.04465982504189, 5857171.763873117044568 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_12_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_12", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_12", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.60003662109375, "elevtn_dn": 795.9000244140625, "invlev_up": 805.10003662109375, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_458_generated", "manhole_dn": "manhole_459_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384425.04465982504189, 5857171.763873117044568 ], [ 1384456.866520966170356, 5857200.577977900393307 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_15_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_15", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_15", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 795.9000244140625, "invlev_up": 793.4000244140625, "invlev_dn": 793.4000244140625, "manhole_up": "manhole_459_generated", "manhole_dn": "manhole_460_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384456.866520966170356, 5857200.577977900393307 ], [ 1384480.774830641923472, 5857195.244455400854349 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_17_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_17", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_17", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 795.9000244140625, "elevtn_dn": 805.0, "invlev_up": 793.4000244140625, "invlev_dn": 802.5, "manhole_up": "manhole_459_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384456.866520966170356, 5857200.577977900393307 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_18_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_18", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_18", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_462_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384493.329776774393395, 5857201.952337642200291 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_19_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_19", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_19", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_462_generated", "manhole_dn": "manhole_463_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384493.329776774393395, 5857201.952337642200291 ], [ 1384511.321100181667134, 5857246.008046119473875 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_19_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_19", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_19", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 805.0, "invlev_up": 802.5, "invlev_dn": 802.5, "manhole_up": "manhole_463_generated", "manhole_dn": "manhole_461_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384511.321100181667134, 5857246.008046119473875 ], [ 1384478.871156033361331, 5857219.682923189364374 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 805.0, "elevtn_dn": 796.29998779296875, "invlev_up": 802.5, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_464_generated", "manhole_dn": "manhole_465_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384512.484966830350459, 5857248.858029337599874 ], [ 1384550.208547196350992, 5857281.609186780638993 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 796.29998779296875, "invlev_up": 793.79998779296875, "invlev_dn": 793.79998779296875, "manhole_up": "manhole_465_generated", "manhole_dn": "manhole_466_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384550.208547196350992, 5857281.609186780638993 ], [ 1384587.932127562351525, 5857314.360344224609435 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 796.29998779296875, "elevtn_dn": 809.10003662109375, "invlev_up": 793.79998779296875, "invlev_dn": 806.60003662109375, "manhole_up": "manhole_466_generated", "manhole_dn": "manhole_467_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384587.932127562351525, 5857314.360344224609435 ], [ 1384608.456866907887161, 5857358.785165345296264 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.10003662109375, "elevtn_dn": 809.10003662109375, "invlev_up": 806.60003662109375, "invlev_dn": 806.60003662109375, "manhole_up": "manhole_467_generated", "manhole_dn": "manhole_468_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384608.456866907887161, 5857358.785165345296264 ], [ 1384624.966163935838267, 5857405.935456342995167 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.10003662109375, "elevtn_dn": 794.29998779296875, "invlev_up": 806.60003662109375, "invlev_dn": 791.79998779296875, "manhole_up": "manhole_468_generated", "manhole_dn": "manhole_469_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384624.966163935838267, 5857405.935456342995167 ], [ 1384639.938245237572119, 5857453.586039477027953 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.29998779296875, "elevtn_dn": 812.4000244140625, "invlev_up": 791.79998779296875, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_469_generated", "manhole_dn": "manhole_470_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384639.938245237572119, 5857453.586039477027953 ], [ 1384654.3423755497206, 5857501.421464210376143 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 812.4000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_470_generated", "manhole_dn": "manhole_471_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384654.3423755497206, 5857501.421464210376143 ], [ 1384665.748858094681054, 5857550.055336253717542 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 812.4000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 809.9000244140625, "manhole_up": "manhole_471_generated", "manhole_dn": "manhole_472_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384665.748858094681054, 5857550.055336253717542 ], [ 1384677.04772660904564, 5857598.717872150242329 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E8", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 812.4000244140625, "elevtn_dn": 818.9000244140625, "invlev_up": 809.9000244140625, "invlev_dn": 816.4000244140625, "manhole_up": "manhole_472_generated", "manhole_dn": "manhole_473_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384677.04772660904564, 5857598.717872150242329 ], [ 1384688.346595123410225, 5857647.380408045835793 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E9", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 818.9000244140625, "elevtn_dn": 818.9000244140625, "invlev_up": 816.4000244140625, "invlev_dn": 816.4000244140625, "manhole_up": "manhole_473_generated", "manhole_dn": "manhole_474_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384688.346595123410225, 5857647.380408045835793 ], [ 1384699.64546363777481, 5857696.042943941429257 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E10", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 818.9000244140625, "elevtn_dn": 791.0, "invlev_up": 816.4000244140625, "invlev_dn": 788.5, "manhole_up": "manhole_474_generated", "manhole_dn": "manhole_475_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384699.64546363777481, 5857696.042943941429257 ], [ 1384710.944332152139395, 5857744.705479837954044 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E11", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 771.9000244140625, "invlev_up": 788.5, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_475_generated", "manhole_dn": "manhole_476_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384710.944332152139395, 5857744.705479837954044 ], [ 1384726.848783193388954, 5857791.671307560056448 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E12", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_476_generated", "manhole_dn": "manhole_477_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384726.848783193388954, 5857791.671307560056448 ], [ 1384753.929338480113074, 5857833.199649352580309 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E13", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 771.9000244140625, "invlev_up": 769.4000244140625, "invlev_dn": 769.4000244140625, "manhole_up": "manhole_477_generated", "manhole_dn": "manhole_478_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384753.929338480113074, 5857833.199649352580309 ], [ 1384783.627482200739905, 5857873.006575288251042 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E14", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.9000244140625, "elevtn_dn": 791.0, "invlev_up": 769.4000244140625, "invlev_dn": 788.5, "manhole_up": "manhole_478_generated", "manhole_dn": "manhole_479_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384783.627482200739905, 5857873.006575288251042 ], [ 1384795.018452654592693, 5857920.637507135979831 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E15", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 791.0, "invlev_up": 788.5, "invlev_dn": 788.5, "manhole_up": "manhole_479_generated", "manhole_dn": "manhole_480_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384795.018452654592693, 5857920.637507135979831 ], [ 1384785.075932276435196, 5857969.445633230730891 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E16", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 791.0, "elevtn_dn": 820.10003662109375, "invlev_up": 788.5, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_480_generated", "manhole_dn": "manhole_481_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384785.075932276435196, 5857969.445633230730891 ], [ 1384771.479073295136914, 5858017.516749874688685 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E17", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 820.10003662109375, "invlev_up": 817.60003662109375, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_481_generated", "manhole_dn": "manhole_482_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384771.479073295136914, 5858017.516749874688685 ], [ 1384763.32518996251747, 5858066.675425447523594 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E18", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 820.10003662109375, "invlev_up": 817.60003662109375, "invlev_dn": 817.60003662109375, "manhole_up": "manhole_482_generated", "manhole_dn": "manhole_483_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384763.32518996251747, 5858066.675425447523594 ], [ 1384757.405406558187678, 5858116.280495692044497 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E19", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 820.10003662109375, "elevtn_dn": 847.0, "invlev_up": 817.60003662109375, "invlev_dn": 844.5, "manhole_up": "manhole_483_generated", "manhole_dn": "manhole_484_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384757.405406558187678, 5858116.280495692044497 ], [ 1384746.211964494548738, 5858164.956996791996062 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E20", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 847.0, "invlev_up": 844.5, "invlev_dn": 844.5, "manhole_up": "manhole_484_generated", "manhole_dn": "manhole_485_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384746.211964494548738, 5858164.956996791996062 ], [ 1384738.028054837835953, 5858213.862443570047617 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E21", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 847.0, "invlev_up": 844.5, "invlev_dn": 844.5, "manhole_up": "manhole_485_generated", "manhole_dn": "manhole_486_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384738.028054837835953, 5858213.862443570047617 ], [ 1384756.479259133106098, 5858259.218586039729416 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E22", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 847.0, "elevtn_dn": 833.20001220703125, "invlev_up": 844.5, "invlev_dn": 830.70001220703125, "manhole_up": "manhole_486_generated", "manhole_dn": "manhole_487_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384756.479259133106098, 5858259.218586039729416 ], [ 1384792.653981153853238, 5858293.25339647103101 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E23", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 833.20001220703125, "elevtn_dn": 762.29998779296875, "invlev_up": 830.70001220703125, "invlev_dn": 759.79998779296875, "manhole_up": "manhole_487_generated", "manhole_dn": "manhole_488_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384792.653981153853238, 5858293.25339647103101 ], [ 1384839.146884107263759, 5858310.949097327888012 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E24", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.29998779296875, "elevtn_dn": 762.29998779296875, "invlev_up": 759.79998779296875, "invlev_dn": 759.79998779296875, "manhole_up": "manhole_488_generated", "manhole_dn": "manhole_489_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384839.146884107263759, 5858310.949097327888012 ], [ 1384888.517509665805846, 5858307.535864246077836 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E25", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.29998779296875, "elevtn_dn": 751.0, "invlev_up": 759.79998779296875, "invlev_dn": 748.5, "manhole_up": "manhole_489_generated", "manhole_dn": "manhole_490_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384888.517509665805846, 5858307.535864246077836 ], [ 1384936.622762819286436, 5858294.068231076002121 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E26", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.0, "elevtn_dn": 751.0, "invlev_up": 748.5, "invlev_dn": 748.5, "manhole_up": "manhole_490_generated", "manhole_dn": "manhole_491_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384936.622762819286436, 5858294.068231076002121 ], [ 1384984.637113286415115, 5858280.272530450485647 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E27", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.0, "elevtn_dn": 743.20001220703125, "invlev_up": 748.5, "invlev_dn": 740.70001220703125, "manhole_up": "manhole_491_generated", "manhole_dn": "manhole_492_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384984.637113286415115, 5858280.272530450485647 ], [ 1385032.633651287527755, 5858266.414710656739771 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E28", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 743.20001220703125, "elevtn_dn": 743.20001220703125, "invlev_up": 740.70001220703125, "invlev_dn": 740.70001220703125, "manhole_up": "manhole_492_generated", "manhole_dn": "manhole_493_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385032.633651287527755, 5858266.414710656739771 ], [ 1385081.886840383987874, 5858258.136644747108221 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E29", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 743.20001220703125, "elevtn_dn": 747.60003662109375, "invlev_up": 740.70001220703125, "invlev_dn": 745.10003662109375, "manhole_up": "manhole_493_generated", "manhole_dn": "manhole_494_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385081.886840383987874, 5858258.136644747108221 ], [ 1385131.310463621048257, 5858263.211211345158517 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E30", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.60003662109375, "elevtn_dn": 756.79998779296875, "invlev_up": 745.10003662109375, "invlev_dn": 754.29998779296875, "manhole_up": "manhole_494_generated", "manhole_dn": "manhole_495_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385131.310463621048257, 5858263.211211345158517 ], [ 1385177.729395114118233, 5858281.168494092300534 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E31", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.79998779296875, "elevtn_dn": 758.9000244140625, "invlev_up": 754.29998779296875, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_495_generated", "manhole_dn": "manhole_496_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385177.729395114118233, 5858281.168494092300534 ], [ 1385219.95651927171275, 5858307.84242575801909 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E32", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 758.9000244140625, "invlev_up": 756.4000244140625, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_496_generated", "manhole_dn": "manhole_497_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385219.95651927171275, 5858307.84242575801909 ], [ 1385261.864506913116202, 5858335.034840167500079 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E33", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 756.29998779296875, "invlev_up": 756.4000244140625, "invlev_dn": 753.79998779296875, "manhole_up": "manhole_497_generated", "manhole_dn": "manhole_498_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385261.864506913116202, 5858335.034840167500079 ], [ 1385305.658712412696332, 5858358.964500648900867 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E34", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 756.29998779296875, "invlev_up": 753.79998779296875, "invlev_dn": 753.79998779296875, "manhole_up": "manhole_498_generated", "manhole_dn": "manhole_499_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385305.658712412696332, 5858358.964500648900867 ], [ 1385350.136275847908109, 5858381.712097893469036 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E35", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 750.79998779296875, "invlev_up": 753.79998779296875, "invlev_dn": 748.29998779296875, "manhole_up": "manhole_499_generated", "manhole_dn": "manhole_500_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385350.136275847908109, 5858381.712097893469036 ], [ 1385394.617425152566284, 5858404.452682325616479 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E36", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 750.79998779296875, "elevtn_dn": 760.20001220703125, "invlev_up": 748.29998779296875, "invlev_dn": 757.70001220703125, "manhole_up": "manhole_500_generated", "manhole_dn": "manhole_501_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385394.617425152566284, 5858404.452682325616479 ], [ 1385439.245915542822331, 5858426.901898948475718 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E37", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 760.20001220703125, "elevtn_dn": 754.29998779296875, "invlev_up": 757.70001220703125, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_501_generated", "manhole_dn": "manhole_502_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385439.245915542822331, 5858426.901898948475718 ], [ 1385483.926139793125913, 5858449.248809035867453 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E38", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 754.29998779296875, "invlev_up": 751.79998779296875, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_502_generated", "manhole_dn": "manhole_503_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385483.926139793125913, 5858449.248809035867453 ], [ 1385525.860647091642022, 5858475.8632338559255 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E39", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 754.29998779296875, "invlev_up": 751.79998779296875, "invlev_dn": 751.79998779296875, "manhole_up": "manhole_503_generated", "manhole_dn": "manhole_504_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385525.860647091642022, 5858475.8632338559255 ], [ 1385553.357332118786871, 5858517.404887572862208 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E40", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 754.29998779296875, "elevtn_dn": 751.70001220703125, "invlev_up": 751.79998779296875, "invlev_dn": 749.20001220703125, "manhole_up": "manhole_504_generated", "manhole_dn": "manhole_505_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385553.357332118786871, 5858517.404887572862208 ], [ 1385579.617479301057756, 5858559.686364834196866 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E41", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.70001220703125, "elevtn_dn": 751.70001220703125, "invlev_up": 749.20001220703125, "invlev_dn": 749.20001220703125, "manhole_up": "manhole_505_generated", "manhole_dn": "manhole_506_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385579.617479301057756, 5858559.686364834196866 ], [ 1385621.905693766893819, 5858585.068030893802643 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E42", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.70001220703125, "elevtn_dn": 750.9000244140625, "invlev_up": 749.20001220703125, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_506_generated", "manhole_dn": "manhole_507_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385621.905693766893819, 5858585.068030893802643 ], [ 1385664.027273919200525, 5858611.351026647724211 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E43", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 750.9000244140625, "invlev_up": 748.4000244140625, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_507_generated", "manhole_dn": "manhole_508_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385664.027273919200525, 5858611.351026647724211 ], [ 1385700.387205619364977, 5858645.507954810746014 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E44", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 750.9000244140625, "invlev_up": 748.4000244140625, "invlev_dn": 748.4000244140625, "manhole_up": "manhole_508_generated", "manhole_dn": "manhole_509_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385700.387205619364977, 5858645.507954810746014 ], [ 1385734.601841112133116, 5858681.909404612146318 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E45", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 750.9000244140625, "elevtn_dn": 755.79998779296875, "invlev_up": 748.4000244140625, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_509_generated", "manhole_dn": "manhole_510_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385734.601841112133116, 5858681.909404612146318 ], [ 1385768.816476604901254, 5858718.310854412615299 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E46", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_510_generated", "manhole_dn": "manhole_511_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385768.816476604901254, 5858718.310854412615299 ], [ 1385802.200311921536922, 5858755.447309947572649 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_20_E47", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_20", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_20", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 755.79998779296875, "invlev_up": 753.29998779296875, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_511_generated", "manhole_dn": "manhole_512_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385802.200311921536922, 5858755.447309947572649 ], [ 1385834.15946239954792, 5858793.844178703613579 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_21_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_21", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.29998779296875, "elevtn_dn": 765.0, "invlev_up": 753.79998779296875, "invlev_dn": 762.5, "manhole_up": "manhole_513_generated", "manhole_dn": "manhole_514_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385352.471788094611838, 5858398.70255031902343 ], [ 1385323.609449510695413, 5858430.098599229939282 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_21_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_21", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 765.0, "elevtn_dn": 765.0, "invlev_up": 762.5, "invlev_dn": 762.5, "manhole_up": "manhole_514_generated", "manhole_dn": "manhole_515_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385323.609449510695413, 5858430.098599229939282 ], [ 1385286.388775944709778, 5858419.306091710925102 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_21_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_21", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 765.0, "elevtn_dn": 758.9000244140625, "invlev_up": 762.5, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_515_generated", "manhole_dn": "manhole_516_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385286.388775944709778, 5858419.306091710925102 ], [ 1385252.458742934046313, 5858394.201654580421746 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_21_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_21", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 758.9000244140625, "invlev_up": 756.4000244140625, "invlev_dn": 756.4000244140625, "manhole_up": "manhole_516_generated", "manhole_dn": "manhole_517_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385252.458742934046313, 5858394.201654580421746 ], [ 1385217.536378393415362, 5858369.72360460460186 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_21_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_21", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_21", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.9000244140625, "elevtn_dn": 756.79998779296875, "invlev_up": 756.4000244140625, "invlev_dn": 754.29998779296875, "manhole_up": "manhole_517_generated", "manhole_dn": "manhole_518_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385217.536378393415362, 5858369.72360460460186 ], [ 1385177.877519500209019, 5858363.975667187944055 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_23_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_23", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "manhole_up": "manhole_519_generated", "manhole_dn": "manhole_520_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384748.107251951703802, 5858475.46539437584579 ], [ 1384773.662756133358926, 5858482.028828926384449 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_23_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_23", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_23", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 813.60003662109375, "elevtn_dn": 813.60003662109375, "invlev_up": 811.10003662109375, "invlev_dn": 811.10003662109375, "manhole_up": "manhole_520_generated", "manhole_dn": "manhole_521_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1384773.662756133358926, 5858482.028828926384449 ], [ 1384799.21826031524688, 5858488.592263477854431 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_24_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_24", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_24", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.9000244140625, "elevtn_dn": 751.4000244140625, "invlev_up": 760.4000244140625, "invlev_dn": 748.9000244140625, "manhole_up": "manhole_522_generated", "manhole_dn": "manhole_523_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385831.554474999429658, 5858837.476550582796335 ], [ 1385834.933234154479578, 5858795.367517679929733 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_24_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_24", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_24", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 751.4000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 748.9000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_523_generated", "manhole_dn": "manhole_524_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385834.933234154479578, 5858795.367517679929733 ], [ 1385855.640895856311545, 5858836.135079927742481 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_25_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_25", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.79998779296875, "elevtn_dn": 791.20001220703125, "invlev_up": 784.29998779296875, "invlev_dn": 788.70001220703125, "manhole_up": "manhole_525_generated", "manhole_dn": "manhole_526_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385425.871741503709927, 5858809.522038951516151 ], [ 1385446.216239683330059, 5858844.397748519666493 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_25_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_25", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 791.20001220703125, "elevtn_dn": 791.20001220703125, "invlev_up": 788.70001220703125, "invlev_dn": 788.70001220703125, "manhole_up": "manhole_526_generated", "manhole_dn": "manhole_527_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385446.216239683330059, 5858844.397748519666493 ], [ 1385453.998638280900195, 5858886.437654017470777 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_25_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_25", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_25", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 791.20001220703125, "elevtn_dn": 783.0, "invlev_up": 788.70001220703125, "invlev_dn": 780.5, "manhole_up": "manhole_527_generated", "manhole_dn": "manhole_528_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385453.998638280900195, 5858886.437654017470777 ], [ 1385472.218053022632375, 5858925.273072509095073 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_26_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_26", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_26", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.9000244140625, "elevtn_dn": 759.70001220703125, "invlev_up": 760.4000244140625, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_522_generated", "manhole_dn": "manhole_524_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385831.554474999429658, 5858837.476550582796335 ], [ 1385855.640895856311545, 5858836.135079927742481 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_29_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_29", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_29", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 759.70001220703125, "invlev_up": 757.20001220703125, "invlev_dn": 757.20001220703125, "manhole_up": "manhole_529_generated", "manhole_dn": "manhole_530_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385861.372513797832653, 5858893.832569030113518 ], [ 1385844.630084188189358, 5858865.848266057670116 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_29_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_29", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_29", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 759.70001220703125, "elevtn_dn": 762.9000244140625, "invlev_up": 757.20001220703125, "invlev_dn": 760.4000244140625, "manhole_up": "manhole_530_generated", "manhole_dn": "manhole_522_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1385844.630084188189358, 5858865.848266057670116 ], [ 1385831.554474999429658, 5858837.476550582796335 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_30_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 769.4000244140625, "invlev_up": 766.9000244140625, "invlev_dn": 766.9000244140625, "manhole_up": "manhole_531_generated", "manhole_dn": "manhole_532_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387137.22300889948383, 5858981.723106959834695 ], [ 1387148.04859330272302, 5859026.366797789931297 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_30_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 769.4000244140625, "elevtn_dn": 762.60003662109375, "invlev_up": 766.9000244140625, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_532_generated", "manhole_dn": "manhole_533_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387148.04859330272302, 5859026.366797789931297 ], [ 1387119.95937648974359, 5859056.934598693624139 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_30_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 762.60003662109375, "invlev_up": 760.10003662109375, "invlev_dn": 760.10003662109375, "manhole_up": "manhole_533_generated", "manhole_dn": "manhole_534_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387119.95937648974359, 5859056.934598693624139 ], [ 1387074.832296247361228, 5859065.30100557859987 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_30_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.60003662109375, "elevtn_dn": 755.79998779296875, "invlev_up": 760.10003662109375, "invlev_dn": 753.29998779296875, "manhole_up": "manhole_534_generated", "manhole_dn": "manhole_535_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387074.832296247361228, 5859065.30100557859987 ], [ 1387030.356415221933275, 5859076.86137125454843 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_30_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.79998779296875, "elevtn_dn": 772.4000244140625, "invlev_up": 753.29998779296875, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_535_generated", "manhole_dn": "manhole_536_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387030.356415221933275, 5859076.86137125454843 ], [ 1386986.427998587489128, 5859090.309648380614817 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_30_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 761.60003662109375, "invlev_up": 769.9000244140625, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_536_generated", "manhole_dn": "manhole_537_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386986.427998587489128, 5859090.309648380614817 ], [ 1386945.966695382725447, 5859111.788386604748666 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_30_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_537_generated", "manhole_dn": "manhole_538_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386945.966695382725447, 5859111.788386604748666 ], [ 1386905.77102447184734, 5859134.105928846634924 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_30_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_30", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_30", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_538_generated", "manhole_dn": "manhole_539_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386905.77102447184734, 5859134.105928846634924 ], [ 1386871.537448140559718, 5859162.609670763835311 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 761.60003662109375, "invlev_up": 759.10003662109375, "invlev_dn": 759.10003662109375, "manhole_up": "manhole_539_generated", "manhole_dn": "manhole_540_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386871.537448140559718, 5859162.609670763835311 ], [ 1386921.106019288301468, 5859163.103915391489863 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 772.4000244140625, "invlev_up": 759.10003662109375, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_540_generated", "manhole_dn": "manhole_541_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386921.106019288301468, 5859163.103915391489863 ], [ 1386970.627896018791944, 5859161.624508504755795 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 772.4000244140625, "invlev_up": 769.9000244140625, "invlev_dn": 769.9000244140625, "manhole_up": "manhole_541_generated", "manhole_dn": "manhole_542_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386970.627896018791944, 5859161.624508504755795 ], [ 1387019.993600395740941, 5859157.412991388700902 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.4000244140625, "elevtn_dn": 781.10003662109375, "invlev_up": 769.9000244140625, "invlev_dn": 778.60003662109375, "manhole_up": "manhole_542_generated", "manhole_dn": "manhole_543_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387019.993600395740941, 5859157.412991388700902 ], [ 1387069.191225855611265, 5859151.340004274621606 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 781.10003662109375, "elevtn_dn": 781.10003662109375, "invlev_up": 778.60003662109375, "invlev_dn": 778.60003662109375, "manhole_up": "manhole_543_generated", "manhole_dn": "manhole_544_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387069.191225855611265, 5859151.340004274621606 ], [ 1387118.547863835236058, 5859146.828392788767815 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 781.10003662109375, "elevtn_dn": 786.4000244140625, "invlev_up": 778.60003662109375, "invlev_dn": 783.9000244140625, "manhole_up": "manhole_544_generated", "manhole_dn": "manhole_545_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387118.547863835236058, 5859146.828392788767815 ], [ 1387167.916038708761334, 5859151.025294326245785 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.4000244140625, "elevtn_dn": 786.4000244140625, "invlev_up": 783.9000244140625, "invlev_dn": 783.9000244140625, "manhole_up": "manhole_545_generated", "manhole_dn": "manhole_546_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387167.916038708761334, 5859151.025294326245785 ], [ 1387217.282604865729809, 5859155.523034786805511 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.4000244140625, "elevtn_dn": 787.60003662109375, "invlev_up": 783.9000244140625, "invlev_dn": 785.10003662109375, "manhole_up": "manhole_546_generated", "manhole_dn": "manhole_547_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387217.282604865729809, 5859155.523034786805511 ], [ 1387266.649171022465453, 5859160.020775248296559 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E8", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 787.60003662109375, "elevtn_dn": 787.60003662109375, "invlev_up": 785.10003662109375, "invlev_dn": 785.10003662109375, "manhole_up": "manhole_547_generated", "manhole_dn": "manhole_548_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387266.649171022465453, 5859160.020775248296559 ], [ 1387315.831188223091885, 5859165.716172898188233 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E9", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 787.60003662109375, "elevtn_dn": 790.4000244140625, "invlev_up": 785.10003662109375, "invlev_dn": 787.9000244140625, "manhole_up": "manhole_548_generated", "manhole_dn": "manhole_549_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387315.831188223091885, 5859165.716172898188233 ], [ 1387364.261764668161049, 5859176.288154195994139 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E10", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 790.4000244140625, "elevtn_dn": 790.4000244140625, "invlev_up": 787.9000244140625, "invlev_dn": 787.9000244140625, "manhole_up": "manhole_549_generated", "manhole_dn": "manhole_550_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387364.261764668161049, 5859176.288154195994139 ], [ 1387411.186259990092367, 5859192.118345031514764 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E11", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 790.4000244140625, "elevtn_dn": 789.10003662109375, "invlev_up": 787.9000244140625, "invlev_dn": 786.60003662109375, "manhole_up": "manhole_550_generated", "manhole_dn": "manhole_551_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387411.186259990092367, 5859192.118345031514764 ], [ 1387455.544592748628929, 5859213.906051598489285 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E12", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 789.10003662109375, "elevtn_dn": 817.20001220703125, "invlev_up": 786.60003662109375, "invlev_dn": 814.70001220703125, "manhole_up": "manhole_551_generated", "manhole_dn": "manhole_552_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387455.544592748628929, 5859213.906051598489285 ], [ 1387490.610425172373652, 5859248.94134864397347 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E13", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 817.20001220703125, "elevtn_dn": 818.20001220703125, "invlev_up": 814.70001220703125, "invlev_dn": 815.70001220703125, "manhole_up": "manhole_552_generated", "manhole_dn": "manhole_553_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387490.610425172373652, 5859248.94134864397347 ], [ 1387525.979065561201423, 5859283.669168318621814 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E14", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 818.20001220703125, "elevtn_dn": 818.20001220703125, "invlev_up": 815.70001220703125, "invlev_dn": 815.70001220703125, "manhole_up": "manhole_553_generated", "manhole_dn": "manhole_554_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387525.979065561201423, 5859283.669168318621814 ], [ 1387563.532416822388768, 5859316.0270627560094 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E15", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 818.20001220703125, "elevtn_dn": 802.79998779296875, "invlev_up": 815.70001220703125, "invlev_dn": 800.29998779296875, "manhole_up": "manhole_554_generated", "manhole_dn": "manhole_555_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387563.532416822388768, 5859316.0270627560094 ], [ 1387601.085768083808944, 5859348.384957193396986 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E16", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 802.79998779296875, "elevtn_dn": 837.70001220703125, "invlev_up": 800.29998779296875, "invlev_dn": 835.20001220703125, "manhole_up": "manhole_555_generated", "manhole_dn": "manhole_556_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387601.085768083808944, 5859348.384957193396986 ], [ 1387638.639119345229119, 5859380.742851630784571 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E17", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 837.70001220703125, "elevtn_dn": 837.70001220703125, "invlev_up": 835.20001220703125, "invlev_dn": 835.20001220703125, "manhole_up": "manhole_556_generated", "manhole_dn": "manhole_557_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387638.639119345229119, 5859380.742851630784571 ], [ 1387676.192470606416464, 5859413.100746068172157 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E18", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 837.70001220703125, "elevtn_dn": 828.79998779296875, "invlev_up": 835.20001220703125, "invlev_dn": 826.29998779296875, "manhole_up": "manhole_557_generated", "manhole_dn": "manhole_558_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387676.192470606416464, 5859413.100746068172157 ], [ 1387713.745821867836639, 5859445.45864050462842 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E19", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 828.79998779296875, "elevtn_dn": 828.79998779296875, "invlev_up": 826.29998779296875, "invlev_dn": 826.29998779296875, "manhole_up": "manhole_558_generated", "manhole_dn": "manhole_559_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387713.745821867836639, 5859445.45864050462842 ], [ 1387750.394377880264074, 5859478.825171477161348 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E20", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 828.79998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 826.29998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_559_generated", "manhole_dn": "manhole_560_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387750.394377880264074, 5859478.825171477161348 ], [ 1387786.626276910537854, 5859512.656178202480078 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E21", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 851.79998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_560_generated", "manhole_dn": "manhole_561_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387786.626276910537854, 5859512.656178202480078 ], [ 1387822.858175940578803, 5859546.487184926867485 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E22", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 854.29998779296875, "invlev_up": 851.79998779296875, "invlev_dn": 851.79998779296875, "manhole_up": "manhole_561_generated", "manhole_dn": "manhole_562_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387822.858175940578803, 5859546.487184926867485 ], [ 1387850.662340233800933, 5859586.980695966631174 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E23", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 854.29998779296875, "elevtn_dn": 891.20001220703125, "invlev_up": 851.79998779296875, "invlev_dn": 888.70001220703125, "manhole_up": "manhole_562_generated", "manhole_dn": "manhole_563_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387850.662340233800933, 5859586.980695966631174 ], [ 1387868.193221996771172, 5859633.330900657922029 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E24", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 891.20001220703125, "elevtn_dn": 876.20001220703125, "invlev_up": 888.70001220703125, "invlev_dn": 873.70001220703125, "manhole_up": "manhole_563_generated", "manhole_dn": "manhole_564_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387868.193221996771172, 5859633.330900657922029 ], [ 1387885.535610173596069, 5859679.769344814121723 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E25", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 876.20001220703125, "elevtn_dn": 876.20001220703125, "invlev_up": 873.70001220703125, "invlev_dn": 873.70001220703125, "manhole_up": "manhole_564_generated", "manhole_dn": "manhole_565_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387885.535610173596069, 5859679.769344814121723 ], [ 1387902.854485532967374, 5859726.216552678495646 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E26", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 876.20001220703125, "elevtn_dn": 898.29998779296875, "invlev_up": 873.70001220703125, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_565_generated", "manhole_dn": "manhole_566_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387902.854485532967374, 5859726.216552678495646 ], [ 1387920.137465380365029, 5859772.67713953461498 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E27", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 898.29998779296875, "invlev_up": 895.79998779296875, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_566_generated", "manhole_dn": "manhole_567_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387920.137465380365029, 5859772.67713953461498 ], [ 1387937.420445227529854, 5859819.137726389802992 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E28", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 898.29998779296875, "invlev_up": 895.79998779296875, "invlev_dn": 895.79998779296875, "manhole_up": "manhole_567_generated", "manhole_dn": "manhole_568_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387937.420445227529854, 5859819.137726389802992 ], [ 1387948.863530882401392, 5859867.082766367122531 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E29", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 898.29998779296875, "elevtn_dn": 918.5, "invlev_up": 895.79998779296875, "invlev_dn": 916.0, "manhole_up": "manhole_568_generated", "manhole_dn": "manhole_569_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387948.863530882401392, 5859867.082766367122531 ], [ 1387950.013254075078294, 5859916.565449987538159 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E30", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 918.5, "invlev_up": 916.0, "invlev_dn": 916.0, "manhole_up": "manhole_569_generated", "manhole_dn": "manhole_570_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387950.013254075078294, 5859916.565449987538159 ], [ 1387947.430782878771424, 5859966.047936389222741 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E31", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 918.5, "invlev_up": 916.0, "invlev_dn": 916.0, "manhole_up": "manhole_570_generated", "manhole_dn": "manhole_571_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387947.430782878771424, 5859966.047936389222741 ], [ 1387943.997958281077445, 5860015.499966060742736 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E32", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 918.5, "elevtn_dn": 948.60003662109375, "invlev_up": 916.0, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_571_generated", "manhole_dn": "manhole_572_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387943.997958281077445, 5860015.499966060742736 ], [ 1387940.565133683150634, 5860064.951995733194053 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E33", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 948.60003662109375, "invlev_up": 946.10003662109375, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_572_generated", "manhole_dn": "manhole_573_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.565133683150634, 5860064.951995733194053 ], [ 1387945.371777657186612, 5860113.959104515612125 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E34", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 948.60003662109375, "invlev_up": 946.10003662109375, "invlev_dn": 946.10003662109375, "manhole_up": "manhole_573_generated", "manhole_dn": "manhole_574_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387945.371777657186612, 5860113.959104515612125 ], [ 1387964.117816498270258, 5860159.736532494425774 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E35", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 948.60003662109375, "elevtn_dn": 940.5, "invlev_up": 946.10003662109375, "invlev_dn": 938.0, "manhole_up": "manhole_574_generated", "manhole_dn": "manhole_575_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387964.117816498270258, 5860159.736532494425774 ], [ 1387984.093857799191028, 5860205.104420888237655 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E36", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 940.5, "invlev_up": 938.0, "invlev_dn": 938.0, "manhole_up": "manhole_575_generated", "manhole_dn": "manhole_576_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387984.093857799191028, 5860205.104420888237655 ], [ 1388004.069899099878967, 5860250.472309282049537 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E37", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 940.5, "invlev_up": 938.0, "invlev_dn": 938.0, "manhole_up": "manhole_576_generated", "manhole_dn": "manhole_577_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388004.069899099878967, 5860250.472309282049537 ], [ 1388027.68692572391592, 5860293.896034284494817 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E38", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 940.5, "elevtn_dn": 971.70001220703125, "invlev_up": 938.0, "invlev_dn": 969.20001220703125, "manhole_up": "manhole_577_generated", "manhole_dn": "manhole_578_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388027.68692572391592, 5860293.896034284494817 ], [ 1388060.096315970877185, 5860331.348726416006684 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E39", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 971.70001220703125, "elevtn_dn": 935.5, "invlev_up": 969.20001220703125, "invlev_dn": 933.0, "manhole_up": "manhole_578_generated", "manhole_dn": "manhole_579_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388060.096315970877185, 5860331.348726416006684 ], [ 1388092.967688721138984, 5860368.453448176383972 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E40", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 935.5, "invlev_up": 933.0, "invlev_dn": 933.0, "manhole_up": "manhole_579_generated", "manhole_dn": "manhole_580_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388092.967688721138984, 5860368.453448176383972 ], [ 1388119.020827289205045, 5860410.510251956991851 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E41", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.5, "elevtn_dn": 949.9000244140625, "invlev_up": 933.0, "invlev_dn": 947.4000244140625, "manhole_up": "manhole_580_generated", "manhole_dn": "manhole_581_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388119.020827289205045, 5860410.510251956991851 ], [ 1388143.407622833969072, 5860453.667774203233421 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E42", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 949.9000244140625, "elevtn_dn": 924.60003662109375, "invlev_up": 947.4000244140625, "invlev_dn": 922.10003662109375, "manhole_up": "manhole_581_generated", "manhole_dn": "manhole_582_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388143.407622833969072, 5860453.667774203233421 ], [ 1388167.794418378733099, 5860496.82529644947499 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E43", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 924.60003662109375, "elevtn_dn": 924.60003662109375, "invlev_up": 922.10003662109375, "invlev_dn": 922.10003662109375, "manhole_up": "manhole_582_generated", "manhole_dn": "manhole_583_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388167.794418378733099, 5860496.82529644947499 ], [ 1388187.41186453984119, 5860542.097804954275489 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E44", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 924.60003662109375, "elevtn_dn": 942.4000244140625, "invlev_up": 922.10003662109375, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_583_generated", "manhole_dn": "manhole_584_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388187.41186453984119, 5860542.097804954275489 ], [ 1388193.385166377527639, 5860591.251542154699564 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E45", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 942.4000244140625, "invlev_up": 939.9000244140625, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_584_generated", "manhole_dn": "manhole_585_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388193.385166377527639, 5860591.251542154699564 ], [ 1388198.812296225922182, 5860640.524595490656793 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E46", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 942.4000244140625, "invlev_up": 939.9000244140625, "invlev_dn": 939.9000244140625, "manhole_up": "manhole_585_generated", "manhole_dn": "manhole_586_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388198.812296225922182, 5860640.524595490656793 ], [ 1388204.239426074549556, 5860689.7976488256827 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E47", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 942.4000244140625, "elevtn_dn": 955.0, "invlev_up": 939.9000244140625, "invlev_dn": 952.5, "manhole_up": "manhole_586_generated", "manhole_dn": "manhole_587_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388204.239426074549556, 5860689.7976488256827 ], [ 1388184.484932377934456, 5860730.700381714850664 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E48", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_587_generated", "manhole_dn": "manhole_588_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388184.484932377934456, 5860730.700381714850664 ], [ 1388159.550175313837826, 5860759.392759991809726 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E49", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_588_generated", "manhole_dn": "manhole_589_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388159.550175313837826, 5860759.392759991809726 ], [ 1388171.988544700434431, 5860807.377908634953201 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E50", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 955.0, "invlev_up": 952.5, "invlev_dn": 952.5, "manhole_up": "manhole_589_generated", "manhole_dn": "manhole_590_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388171.988544700434431, 5860807.377908634953201 ], [ 1388215.013825689908117, 5860825.214942933060229 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E51", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.0, "elevtn_dn": 941.10003662109375, "invlev_up": 952.5, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_590_generated", "manhole_dn": "manhole_591_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388215.013825689908117, 5860825.214942933060229 ], [ 1388264.397385431453586, 5860829.298032846301794 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E52", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 941.10003662109375, "invlev_up": 938.60003662109375, "invlev_dn": 938.60003662109375, "manhole_up": "manhole_591_generated", "manhole_dn": "manhole_592_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388264.397385431453586, 5860829.298032846301794 ], [ 1388313.062299854354933, 5860837.304878970608115 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E53", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.10003662109375, "elevtn_dn": 937.5, "invlev_up": 938.60003662109375, "invlev_dn": 935.0, "manhole_up": "manhole_592_generated", "manhole_dn": "manhole_593_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388313.062299854354933, 5860837.304878970608115 ], [ 1388360.993895401246846, 5860849.948045967146754 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E54", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.5, "elevtn_dn": 937.5, "invlev_up": 935.0, "invlev_dn": 935.0, "manhole_up": "manhole_593_generated", "manhole_dn": "manhole_594_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388360.993895401246846, 5860849.948045967146754 ], [ 1388408.925490947905928, 5860862.591212964616716 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E55", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.5, "elevtn_dn": 937.60003662109375, "invlev_up": 935.0, "invlev_dn": 935.10003662109375, "manhole_up": "manhole_594_generated", "manhole_dn": "manhole_595_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388408.925490947905928, 5860862.591212964616716 ], [ 1388458.220990223577246, 5860866.957201769575477 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E56", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.60003662109375, "elevtn_dn": 937.60003662109375, "invlev_up": 935.10003662109375, "invlev_dn": 935.10003662109375, "manhole_up": "manhole_595_generated", "manhole_dn": "manhole_596_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388458.220990223577246, 5860866.957201769575477 ], [ 1388507.336333080893382, 5860873.218384950421751 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E57", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.60003662109375, "elevtn_dn": 941.20001220703125, "invlev_up": 935.10003662109375, "invlev_dn": 938.70001220703125, "manhole_up": "manhole_596_generated", "manhole_dn": "manhole_597_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388507.336333080893382, 5860873.218384950421751 ], [ 1388556.215695114107803, 5860881.470384138636291 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E58", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.20001220703125, "elevtn_dn": 941.20001220703125, "invlev_up": 938.70001220703125, "invlev_dn": 938.70001220703125, "manhole_up": "manhole_597_generated", "manhole_dn": "manhole_598_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388556.215695114107803, 5860881.470384138636291 ], [ 1388604.556662159739062, 5860892.361969010904431 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E59", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 941.20001220703125, "elevtn_dn": 943.10003662109375, "invlev_up": 938.70001220703125, "invlev_dn": 940.60003662109375, "manhole_up": "manhole_598_generated", "manhole_dn": "manhole_599_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388604.556662159739062, 5860892.361969010904431 ], [ 1388653.59940263046883, 5860897.15789801068604 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E60", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 943.10003662109375, "elevtn_dn": 943.10003662109375, "invlev_up": 940.60003662109375, "invlev_dn": 940.60003662109375, "manhole_up": "manhole_599_generated", "manhole_dn": "manhole_600_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388653.59940263046883, 5860897.15789801068604 ], [ 1388700.080393208190799, 5860881.090511013753712 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E61", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 943.10003662109375, "elevtn_dn": 946.10003662109375, "invlev_up": 940.60003662109375, "invlev_dn": 943.60003662109375, "manhole_up": "manhole_600_generated", "manhole_dn": "manhole_601_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388700.080393208190799, 5860881.090511013753712 ], [ 1388732.687003659084439, 5860844.794781206175685 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E62", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 946.10003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 943.60003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_601_generated", "manhole_dn": "manhole_602_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388732.687003659084439, 5860844.794781206175685 ], [ 1388755.953327334951609, 5860801.023035684600472 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E63", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 950.10003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_602_generated", "manhole_dn": "manhole_603_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388755.953327334951609, 5860801.023035684600472 ], [ 1388778.23369869007729, 5860756.84024004638195 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E64", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 952.60003662109375, "invlev_up": 950.10003662109375, "invlev_dn": 950.10003662109375, "manhole_up": "manhole_603_generated", "manhole_dn": "manhole_604_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388778.23369869007729, 5860756.84024004638195 ], [ 1388792.950793598080054, 5860709.504263866692781 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E65", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.60003662109375, "elevtn_dn": 953.79998779296875, "invlev_up": 950.10003662109375, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_604_generated", "manhole_dn": "manhole_605_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388792.950793598080054, 5860709.504263866692781 ], [ 1388807.667888506315649, 5860662.168287687934935 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E66", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_605_generated", "manhole_dn": "manhole_606_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388807.667888506315649, 5860662.168287687934935 ], [ 1388819.224422588944435, 5860613.968191100284457 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E67", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 955.70001220703125, "invlev_up": 951.29998779296875, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_606_generated", "manhole_dn": "manhole_607_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388819.224422588944435, 5860613.968191100284457 ], [ 1388830.63825476472266, 5860565.72907877061516 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E68", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_607_generated", "manhole_dn": "manhole_608_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388830.63825476472266, 5860565.72907877061516 ], [ 1388842.052086940500885, 5860517.489966440014541 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E69", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_608_generated", "manhole_dn": "manhole_609_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388842.052086940500885, 5860517.489966440014541 ], [ 1388862.77624000934884, 5860472.578981296159327 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E70", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 964.70001220703125, "invlev_up": 953.20001220703125, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_609_generated", "manhole_dn": "manhole_610_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388862.77624000934884, 5860472.578981296159327 ], [ 1388884.529400010826066, 5860428.03588358964771 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E71", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 951.29998779296875, "invlev_up": 962.20001220703125, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_610_generated", "manhole_dn": "manhole_611_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388884.529400010826066, 5860428.03588358964771 ], [ 1388906.282637836178765, 5860383.492823889479041 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E72", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_611_generated", "manhole_dn": "manhole_612_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388906.282637836178765, 5860383.492823889479041 ], [ 1388933.946375871310011, 5860342.419800435192883 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_32_E73", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_32", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_32", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 951.29998779296875, "invlev_up": 948.79998779296875, "invlev_dn": 948.79998779296875, "manhole_up": "manhole_612_generated", "manhole_dn": "manhole_613_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388933.946375871310011, 5860342.419800435192883 ], [ 1388962.240715913940221, 5860301.717001453973353 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_33_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.60003662109375, "elevtn_dn": 752.29998779296875, "invlev_up": 759.10003662109375, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_539_generated", "manhole_dn": "manhole_614_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386871.537448140559718, 5859162.609670763835311 ], [ 1386825.19834817154333, 5859175.156894122250378 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_33_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 752.29998779296875, "invlev_up": 749.79998779296875, "invlev_dn": 749.79998779296875, "manhole_up": "manhole_614_generated", "manhole_dn": "manhole_615_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386825.19834817154333, 5859175.156894122250378 ], [ 1386779.333999397465959, 5859189.44842192158103 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_33_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 752.29998779296875, "elevtn_dn": 738.0, "invlev_up": 749.79998779296875, "invlev_dn": 735.5, "manhole_up": "manhole_615_generated", "manhole_dn": "manhole_616_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386779.333999397465959, 5859189.44842192158103 ], [ 1386733.445003136992455, 5859203.660136871039867 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_33_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 738.0, "invlev_up": 735.5, "invlev_dn": 735.5, "manhole_up": "manhole_616_generated", "manhole_dn": "manhole_617_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386733.445003136992455, 5859203.660136871039867 ], [ 1386687.508546756347641, 5859217.718167688697577 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_33_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 738.0, "elevtn_dn": 763.29998779296875, "invlev_up": 735.5, "invlev_dn": 760.79998779296875, "manhole_up": "manhole_617_generated", "manhole_dn": "manhole_618_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386687.508546756347641, 5859217.718167688697577 ], [ 1386641.572090375469998, 5859231.776198507286608 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_33_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 763.29998779296875, "elevtn_dn": 763.29998779296875, "invlev_up": 760.79998779296875, "invlev_dn": 760.79998779296875, "manhole_up": "manhole_618_generated", "manhole_dn": "manhole_619_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386641.572090375469998, 5859231.776198507286608 ], [ 1386595.451642262749374, 5859245.168246414512396 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_33_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 763.29998779296875, "elevtn_dn": 754.60003662109375, "invlev_up": 760.79998779296875, "invlev_dn": 752.10003662109375, "manhole_up": "manhole_619_generated", "manhole_dn": "manhole_620_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386595.451642262749374, 5859245.168246414512396 ], [ 1386548.813360751140863, 5859256.685926430858672 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_33_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 754.60003662109375, "elevtn_dn": 754.60003662109375, "invlev_up": 752.10003662109375, "invlev_dn": 752.10003662109375, "manhole_up": "manhole_620_generated", "manhole_dn": "manhole_621_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386548.813360751140863, 5859256.685926430858672 ], [ 1386502.175079239532351, 5859268.203606447204947 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_33_E8", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 754.60003662109375, "elevtn_dn": 742.5, "invlev_up": 752.10003662109375, "invlev_dn": 740.0, "manhole_up": "manhole_621_generated", "manhole_dn": "manhole_622_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386502.175079239532351, 5859268.203606447204947 ], [ 1386455.354356503346935, 5859278.943273726850748 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_33_E9", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 742.5, "invlev_up": 740.0, "invlev_dn": 740.0, "manhole_up": "manhole_622_generated", "manhole_dn": "manhole_623_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386455.354356503346935, 5859278.943273726850748 ], [ 1386408.879239794565365, 5859290.671229789964855 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_33_E10", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 742.5, "elevtn_dn": 717.60003662109375, "invlev_up": 740.0, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_623_generated", "manhole_dn": "manhole_624_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386408.879239794565365, 5859290.671229789964855 ], [ 1386364.691368696978316, 5859309.518465746194124 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_33_E11", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 717.60003662109375, "invlev_up": 715.10003662109375, "invlev_dn": 715.10003662109375, "manhole_up": "manhole_624_generated", "manhole_dn": "manhole_625_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386364.691368696978316, 5859309.518465746194124 ], [ 1386320.503497599391267, 5859328.365701701492071 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_33_E12", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_33", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_33", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 717.60003662109375, "elevtn_dn": 711.0, "invlev_up": 715.10003662109375, "invlev_dn": 708.5, "manhole_up": "manhole_625_generated", "manhole_dn": "manhole_626_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386320.503497599391267, 5859328.365701701492071 ], [ 1386273.173811787506565, 5859335.36546028777957 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 951.29998779296875, "elevtn_dn": 953.70001220703125, "invlev_up": 948.79998779296875, "invlev_dn": 951.20001220703125, "manhole_up": "manhole_10_generated", "manhole_dn": "manhole_627_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388946.301100668497384, 5860414.883977899327874 ], [ 1388922.246059404918924, 5860458.418739438988268 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.70001220703125, "elevtn_dn": 953.70001220703125, "invlev_up": 951.20001220703125, "invlev_dn": 951.20001220703125, "manhole_up": "manhole_627_generated", "manhole_dn": "manhole_628_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388922.246059404918924, 5860458.418739438988268 ], [ 1388900.295977992936969, 5860503.075897979550064 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.70001220703125, "elevtn_dn": 955.70001220703125, "invlev_up": 951.20001220703125, "invlev_dn": 953.20001220703125, "manhole_up": "manhole_628_generated", "manhole_dn": "manhole_629_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388900.295977992936969, 5860503.075897979550064 ], [ 1388878.345896581187844, 5860547.733056520111859 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 955.70001220703125, "elevtn_dn": 953.79998779296875, "invlev_up": 953.20001220703125, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_629_generated", "manhole_dn": "manhole_630_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388878.345896581187844, 5860547.733056520111859 ], [ 1388856.887740465346724, 5860592.570927501656115 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_630_generated", "manhole_dn": "manhole_631_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388856.887740465346724, 5860592.570927501656115 ], [ 1388853.076019846601412, 5860641.795407227240503 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 953.79998779296875, "invlev_up": 951.29998779296875, "invlev_dn": 951.29998779296875, "manhole_up": "manhole_631_generated", "manhole_dn": "manhole_632_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388853.076019846601412, 5860641.795407227240503 ], [ 1388856.119826921960339, 5860691.462329030036926 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 953.79998779296875, "elevtn_dn": 952.5, "invlev_up": 951.29998779296875, "invlev_dn": 950.0, "manhole_up": "manhole_632_generated", "manhole_dn": "manhole_633_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388856.119826921960339, 5860691.462329030036926 ], [ 1388859.163633997086436, 5860741.12925083283335 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.5, "elevtn_dn": 952.5, "invlev_up": 950.0, "invlev_dn": 950.0, "manhole_up": "manhole_633_generated", "manhole_dn": "manhole_634_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388859.163633997086436, 5860741.12925083283335 ], [ 1388862.207441072445363, 5860790.796172635629773 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E8", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.5, "elevtn_dn": 945.5, "invlev_up": 950.0, "invlev_dn": 943.0, "manhole_up": "manhole_634_generated", "manhole_dn": "manhole_635_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388862.207441072445363, 5860790.796172635629773 ], [ 1388866.356326055014506, 5860840.344227194786072 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E9", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 945.5, "invlev_up": 943.0, "invlev_dn": 943.0, "manhole_up": "manhole_635_generated", "manhole_dn": "manhole_636_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388866.356326055014506, 5860840.344227194786072 ], [ 1388873.944740658160299, 5860889.522310186177492 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E10", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 945.5, "invlev_up": 943.0, "invlev_dn": 943.0, "manhole_up": "manhole_636_generated", "manhole_dn": "manhole_637_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388873.944740658160299, 5860889.522310186177492 ], [ 1388883.17427325528115, 5860938.398467163555324 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E11", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 945.5, "elevtn_dn": 937.4000244140625, "invlev_up": 943.0, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_637_generated", "manhole_dn": "manhole_638_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388883.17427325528115, 5860938.398467163555324 ], [ 1388890.216840920504183, 5860987.212368851527572 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E12", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 937.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_638_generated", "manhole_dn": "manhole_639_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388890.216840920504183, 5860987.212368851527572 ], [ 1388884.322194910608232, 5861036.62209493201226 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E13", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 937.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 934.9000244140625, "manhole_up": "manhole_639_generated", "manhole_dn": "manhole_640_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388884.322194910608232, 5861036.62209493201226 ], [ 1388878.427548900712281, 5861086.031821011565626 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E14", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 937.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 934.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_640_generated", "manhole_dn": "manhole_641_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388878.427548900712281, 5861086.031821011565626 ], [ 1388872.532902890816331, 5861135.441547092050314 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E15", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 927.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_641_generated", "manhole_dn": "manhole_642_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388872.532902890816331, 5861135.441547092050314 ], [ 1388866.63825688092038, 5861184.851273172535002 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E16", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 930.4000244140625, "invlev_up": 927.9000244140625, "invlev_dn": 927.9000244140625, "manhole_up": "manhole_642_generated", "manhole_dn": "manhole_643_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388866.63825688092038, 5861184.851273172535002 ], [ 1388854.620840607210994, 5861232.489912945777178 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E17", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 930.4000244140625, "elevtn_dn": 926.60003662109375, "invlev_up": 927.9000244140625, "invlev_dn": 924.10003662109375, "manhole_up": "manhole_643_generated", "manhole_dn": "manhole_644_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388854.620840607210994, 5861232.489912945777178 ], [ 1388833.22756120422855, 5861277.416469449177384 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E18", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 926.60003662109375, "elevtn_dn": 926.60003662109375, "invlev_up": 924.10003662109375, "invlev_dn": 924.10003662109375, "manhole_up": "manhole_644_generated", "manhole_dn": "manhole_645_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388833.22756120422855, 5861277.416469449177384 ], [ 1388811.834281801246107, 5861322.343025953508914 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E19", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 926.60003662109375, "elevtn_dn": 931.10003662109375, "invlev_up": 924.10003662109375, "invlev_dn": 928.60003662109375, "manhole_up": "manhole_645_generated", "manhole_dn": "manhole_646_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388811.834281801246107, 5861322.343025953508914 ], [ 1388790.441002398030832, 5861367.26958245690912 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E20", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 931.10003662109375, "elevtn_dn": 922.20001220703125, "invlev_up": 928.60003662109375, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_646_generated", "manhole_dn": "manhole_647_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388790.441002398030832, 5861367.26958245690912 ], [ 1388769.047722995048389, 5861412.196138960309327 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E21", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 922.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_647_generated", "manhole_dn": "manhole_648_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388769.047722995048389, 5861412.196138960309327 ], [ 1388747.654443592065945, 5861457.122695464640856 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E22", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 922.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 919.70001220703125, "manhole_up": "manhole_648_generated", "manhole_dn": "manhole_649_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388747.654443592065945, 5861457.122695464640856 ], [ 1388725.026126575190574, 5861501.410491958260536 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E23", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 922.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 919.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_649_generated", "manhole_dn": "manhole_650_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388725.026126575190574, 5861501.410491958260536 ], [ 1388700.725248141447082, 5861544.833241644315422 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E24", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_650_generated", "manhole_dn": "manhole_651_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388700.725248141447082, 5861544.833241644315422 ], [ 1388676.42436970770359, 5861588.255991329438984 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E25", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_651_generated", "manhole_dn": "manhole_652_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388676.42436970770359, 5861588.255991329438984 ], [ 1388632.324464634526521, 5861606.441272142343223 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E26", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 898.4000244140625, "invlev_up": 897.70001220703125, "invlev_dn": 895.9000244140625, "manhole_up": "manhole_652_generated", "manhole_dn": "manhole_653_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388632.324464634526521, 5861606.441272142343223 ], [ 1388583.463808472501114, 5861611.105615227483213 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E27", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 898.4000244140625, "elevtn_dn": 898.4000244140625, "invlev_up": 895.9000244140625, "invlev_dn": 895.9000244140625, "manhole_up": "manhole_653_generated", "manhole_dn": "manhole_654_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388583.463808472501114, 5861611.105615227483213 ], [ 1388534.764012826373801, 5861604.222017968073487 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E28", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 898.4000244140625, "elevtn_dn": 903.60003662109375, "invlev_up": 895.9000244140625, "invlev_dn": 901.10003662109375, "manhole_up": "manhole_654_generated", "manhole_dn": "manhole_655_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388534.764012826373801, 5861604.222017968073487 ], [ 1388489.566489090910181, 5861583.40731808822602 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E29", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 903.60003662109375, "elevtn_dn": 903.60003662109375, "invlev_up": 901.10003662109375, "invlev_dn": 901.10003662109375, "manhole_up": "manhole_655_generated", "manhole_dn": "manhole_656_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388489.566489090910181, 5861583.40731808822602 ], [ 1388444.204915680922568, 5861563.162508152425289 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E30", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 903.60003662109375, "elevtn_dn": 906.4000244140625, "invlev_up": 901.10003662109375, "invlev_dn": 903.9000244140625, "manhole_up": "manhole_656_generated", "manhole_dn": "manhole_657_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388444.204915680922568, 5861563.162508152425289 ], [ 1388394.858231473481283, 5861556.761520680040121 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E31", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 906.4000244140625, "elevtn_dn": 906.4000244140625, "invlev_up": 903.9000244140625, "invlev_dn": 903.9000244140625, "manhole_up": "manhole_657_generated", "manhole_dn": "manhole_658_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388394.858231473481283, 5861556.761520680040121 ], [ 1388350.680838279658929, 5861570.408674017526209 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E32", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 906.4000244140625, "elevtn_dn": 900.20001220703125, "invlev_up": 903.9000244140625, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_658_generated", "manhole_dn": "manhole_659_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388350.680838279658929, 5861570.408674017526209 ], [ 1388310.581732882419601, 5861599.872713611461222 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E33", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 900.20001220703125, "invlev_up": 897.70001220703125, "invlev_dn": 897.70001220703125, "manhole_up": "manhole_659_generated", "manhole_dn": "manhole_660_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388310.581732882419601, 5861599.872713611461222 ], [ 1388271.039625711739063, 5861629.969603477045894 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E34", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 900.20001220703125, "elevtn_dn": 890.0, "invlev_up": 897.70001220703125, "invlev_dn": 887.5, "manhole_up": "manhole_660_generated", "manhole_dn": "manhole_661_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388271.039625711739063, 5861629.969603477045894 ], [ 1388236.722210306907073, 5861666.002683873288333 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E35", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 890.0, "invlev_up": 887.5, "invlev_dn": 887.5, "manhole_up": "manhole_661_generated", "manhole_dn": "manhole_662_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388236.722210306907073, 5861666.002683873288333 ], [ 1388202.404794902307913, 5861702.035764269530773 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E36", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 890.0, "invlev_up": 887.5, "invlev_dn": 887.5, "manhole_up": "manhole_662_generated", "manhole_dn": "manhole_663_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388202.404794902307913, 5861702.035764269530773 ], [ 1388168.087379497475922, 5861738.068844665773213 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E37", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 890.0, "elevtn_dn": 885.9000244140625, "invlev_up": 887.5, "invlev_dn": 883.4000244140625, "manhole_up": "manhole_663_generated", "manhole_dn": "manhole_664_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388168.087379497475922, 5861738.068844665773213 ], [ 1388133.769964092643932, 5861774.101925062015653 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E38", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 885.9000244140625, "elevtn_dn": 874.0, "invlev_up": 883.4000244140625, "invlev_dn": 871.5, "manhole_up": "manhole_664_generated", "manhole_dn": "manhole_665_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388133.769964092643932, 5861774.101925062015653 ], [ 1388099.452548687811941, 5861810.13500545732677 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E39", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 874.0, "elevtn_dn": 874.0, "invlev_up": 871.5, "invlev_dn": 871.5, "manhole_up": "manhole_665_generated", "manhole_dn": "manhole_666_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388099.452548687811941, 5861810.13500545732677 ], [ 1388065.135133283212781, 5861846.16808585356921 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E40", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 874.0, "elevtn_dn": 862.20001220703125, "invlev_up": 871.5, "invlev_dn": 859.70001220703125, "manhole_up": "manhole_666_generated", "manhole_dn": "manhole_667_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388065.135133283212781, 5861846.16808585356921 ], [ 1388022.995196633273736, 5861866.899685021489859 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E41", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 862.20001220703125, "elevtn_dn": 862.20001220703125, "invlev_up": 859.70001220703125, "invlev_dn": 859.70001220703125, "manhole_up": "manhole_667_generated", "manhole_dn": "manhole_668_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388022.995196633273736, 5861866.899685021489859 ], [ 1387973.690499771386385, 5861873.616436487063766 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E42", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 862.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 859.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_668_generated", "manhole_dn": "manhole_669_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387973.690499771386385, 5861873.616436487063766 ], [ 1387924.470484273741022, 5861880.90659652557224 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E43", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_669_generated", "manhole_dn": "manhole_670_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387924.470484273741022, 5861880.90659652557224 ], [ 1387877.962616891367361, 5861896.157046243548393 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E44", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_670_generated", "manhole_dn": "manhole_671_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387877.962616891367361, 5861896.157046243548393 ], [ 1387917.070526217576116, 5861911.915829903446138 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E45", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 859.20001220703125, "invlev_up": 856.70001220703125, "invlev_dn": 856.70001220703125, "manhole_up": "manhole_671_generated", "manhole_dn": "manhole_672_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387917.070526217576116, 5861911.915829903446138 ], [ 1387966.654667611001059, 5861916.096835186704993 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E46", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 859.20001220703125, "elevtn_dn": 846.29998779296875, "invlev_up": 856.70001220703125, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_672_generated", "manhole_dn": "manhole_673_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387966.654667611001059, 5861916.096835186704993 ], [ 1388016.318005530629307, 5861919.063731476664543 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E47", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 850.10003662109375, "invlev_up": 843.79998779296875, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_673_generated", "manhole_dn": "manhole_674_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388016.318005530629307, 5861919.063731476664543 ], [ 1388066.025120510486886, 5861921.359510923735797 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E48", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 850.10003662109375, "invlev_up": 847.60003662109375, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_674_generated", "manhole_dn": "manhole_675_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388066.025120510486886, 5861921.359510923735797 ], [ 1388115.732235490344465, 5861923.655290370807052 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E49", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 849.0, "invlev_up": 847.60003662109375, "invlev_dn": 846.5, "manhole_up": "manhole_675_generated", "manhole_dn": "manhole_676_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388115.732235490344465, 5861923.655290370807052 ], [ 1388161.130695321131498, 5861931.457672152668238 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E50", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 849.0, "elevtn_dn": 850.10003662109375, "invlev_up": 846.5, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_676_generated", "manhole_dn": "manhole_677_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388161.130695321131498, 5861931.457672152668238 ], [ 1388139.871223766123876, 5861964.082641129381955 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E51", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 850.10003662109375, "invlev_up": 847.60003662109375, "invlev_dn": 847.60003662109375, "manhole_up": "manhole_677_generated", "manhole_dn": "manhole_678_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388139.871223766123876, 5861964.082641129381955 ], [ 1388090.726845995755866, 5861957.769498392008245 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E52", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 850.10003662109375, "elevtn_dn": 846.29998779296875, "invlev_up": 847.60003662109375, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_678_generated", "manhole_dn": "manhole_679_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388090.726845995755866, 5861957.769498392008245 ], [ 1388049.339104855433106, 5861983.736727176234126 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E53", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 846.29998779296875, "invlev_up": 843.79998779296875, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_679_generated", "manhole_dn": "manhole_680_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388049.339104855433106, 5861983.736727176234126 ], [ 1388024.713075590552762, 5862026.975905770435929 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E54", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 846.29998779296875, "invlev_up": 843.79998779296875, "invlev_dn": 843.79998779296875, "manhole_up": "manhole_680_generated", "manhole_dn": "manhole_681_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388024.713075590552762, 5862026.975905770435929 ], [ 1387980.016218039905652, 5862047.702198376879096 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E55", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 846.29998779296875, "elevtn_dn": 793.5, "invlev_up": 843.79998779296875, "invlev_dn": 791.0, "manhole_up": "manhole_681_generated", "manhole_dn": "manhole_682_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387980.016218039905652, 5862047.702198376879096 ], [ 1387931.90673128189519, 5862056.853296543471515 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E56", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.5, "elevtn_dn": 793.5, "invlev_up": 791.0, "invlev_dn": 791.0, "manhole_up": "manhole_682_generated", "manhole_dn": "manhole_683_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387931.90673128189519, 5862056.853296543471515 ], [ 1387882.187313467729837, 5862058.865105460397899 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E57", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.5, "elevtn_dn": 793.20001220703125, "invlev_up": 791.0, "invlev_dn": 790.70001220703125, "manhole_up": "manhole_683_generated", "manhole_dn": "manhole_684_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387882.187313467729837, 5862058.865105460397899 ], [ 1387832.722497318405658, 5862057.3410848621279 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E58", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.20001220703125, "elevtn_dn": 830.29998779296875, "invlev_up": 790.70001220703125, "invlev_dn": 827.79998779296875, "manhole_up": "manhole_684_generated", "manhole_dn": "manhole_685_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387832.722497318405658, 5862057.3410848621279 ], [ 1387783.80423084856011, 5862048.226750630885363 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E59", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 830.29998779296875, "elevtn_dn": 817.70001220703125, "invlev_up": 827.79998779296875, "invlev_dn": 815.20001220703125, "manhole_up": "manhole_685_generated", "manhole_dn": "manhole_686_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387783.80423084856011, 5862048.226750630885363 ], [ 1387734.885964378714561, 5862039.112416399642825 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E60", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 817.70001220703125, "elevtn_dn": 813.70001220703125, "invlev_up": 815.20001220703125, "invlev_dn": 811.20001220703125, "manhole_up": "manhole_686_generated", "manhole_dn": "manhole_687_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387734.885964378714561, 5862039.112416399642825 ], [ 1387685.967697908869013, 5862029.998082168400288 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E61", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 813.70001220703125, "elevtn_dn": 813.70001220703125, "invlev_up": 811.20001220703125, "invlev_dn": 811.20001220703125, "manhole_up": "manhole_687_generated", "manhole_dn": "manhole_688_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387685.967697908869013, 5862029.998082168400288 ], [ 1387637.036115845199674, 5862020.957140567712486 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E62", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 813.70001220703125, "elevtn_dn": 807.0, "invlev_up": 811.20001220703125, "invlev_dn": 804.5, "manhole_up": "manhole_688_generated", "manhole_dn": "manhole_689_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387637.036115845199674, 5862020.957140567712486 ], [ 1387588.033849656581879, 5862012.305794355459511 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E63", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.0, "elevtn_dn": 807.0, "invlev_up": 804.5, "invlev_dn": 804.5, "manhole_up": "manhole_689_generated", "manhole_dn": "manhole_690_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387588.033849656581879, 5862012.305794355459511 ], [ 1387539.031583468196914, 5862003.654448143206537 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E64", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 807.0, "elevtn_dn": 793.10003662109375, "invlev_up": 804.5, "invlev_dn": 790.60003662109375, "manhole_up": "manhole_690_generated", "manhole_dn": "manhole_691_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387539.031583468196914, 5862003.654448143206537 ], [ 1387490.029317279579118, 5861995.003101930953562 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E65", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.10003662109375, "elevtn_dn": 793.10003662109375, "invlev_up": 790.60003662109375, "invlev_dn": 790.60003662109375, "manhole_up": "manhole_691_generated", "manhole_dn": "manhole_692_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387490.029317279579118, 5861995.003101930953562 ], [ 1387440.720367865404114, 5861989.908138634636998 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E66", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 793.10003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 790.60003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_692_generated", "manhole_dn": "manhole_693_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387440.720367865404114, 5861989.908138634636998 ], [ 1387390.960446665296331, 5861990.042768024839461 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E67", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 770.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 768.10003662109375, "manhole_up": "manhole_693_generated", "manhole_dn": "manhole_694_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387390.960446665296331, 5861990.042768024839461 ], [ 1387341.200525465421379, 5861990.177397414110601 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E68", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 770.60003662109375, "elevtn_dn": 749.60003662109375, "invlev_up": 768.10003662109375, "invlev_dn": 747.10003662109375, "manhole_up": "manhole_694_generated", "manhole_dn": "manhole_695_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387341.200525465421379, 5861990.177397414110601 ], [ 1387291.440604265546426, 5861990.312026804313064 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E69", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 749.60003662109375, "elevtn_dn": 749.60003662109375, "invlev_up": 747.10003662109375, "invlev_dn": 747.10003662109375, "manhole_up": "manhole_695_generated", "manhole_dn": "manhole_696_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387291.440604265546426, 5861990.312026804313064 ], [ 1387246.706285298336297, 5861974.212805554270744 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E70", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 749.60003662109375, "elevtn_dn": 747.0, "invlev_up": 747.10003662109375, "invlev_dn": 744.5, "manhole_up": "manhole_696_generated", "manhole_dn": "manhole_697_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387246.706285298336297, 5861974.212805554270744 ], [ 1387205.725988702848554, 5861945.987228964455426 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E71", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.0, "elevtn_dn": 771.79998779296875, "invlev_up": 744.5, "invlev_dn": 769.29998779296875, "manhole_up": "manhole_697_generated", "manhole_dn": "manhole_698_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387205.725988702848554, 5861945.987228964455426 ], [ 1387164.745692107127979, 5861917.761652374640107 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E72", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 771.79998779296875, "elevtn_dn": 764.10003662109375, "invlev_up": 769.29998779296875, "invlev_dn": 761.60003662109375, "manhole_up": "manhole_698_generated", "manhole_dn": "manhole_699_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387164.745692107127979, 5861917.761652374640107 ], [ 1387115.569933785125613, 5861911.215812381356955 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E73", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 764.10003662109375, "elevtn_dn": 764.10003662109375, "invlev_up": 761.60003662109375, "invlev_dn": 761.60003662109375, "manhole_up": "manhole_699_generated", "manhole_dn": "manhole_700_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387115.569933785125613, 5861911.215812381356955 ], [ 1387066.165866439929232, 5861905.273926095105708 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E74", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 764.10003662109375, "elevtn_dn": 747.70001220703125, "invlev_up": 761.60003662109375, "invlev_dn": 745.20001220703125, "manhole_up": "manhole_700_generated", "manhole_dn": "manhole_701_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387066.165866439929232, 5861905.273926095105708 ], [ 1387016.666836149292067, 5861900.238133460283279 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E75", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.70001220703125, "elevtn_dn": 747.70001220703125, "invlev_up": 745.20001220703125, "invlev_dn": 745.20001220703125, "manhole_up": "manhole_701_generated", "manhole_dn": "manhole_702_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387016.666836149292067, 5861900.238133460283279 ], [ 1386975.698310127714649, 5861874.842493440955877 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E76", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 747.70001220703125, "elevtn_dn": 739.60003662109375, "invlev_up": 745.20001220703125, "invlev_dn": 737.10003662109375, "manhole_up": "manhole_702_generated", "manhole_dn": "manhole_703_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386975.698310127714649, 5861874.842493440955877 ], [ 1386937.286019780673087, 5861843.21080310922116 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E77", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 739.60003662109375, "elevtn_dn": 739.60003662109375, "invlev_up": 737.10003662109375, "invlev_dn": 737.10003662109375, "manhole_up": "manhole_703_generated", "manhole_dn": "manhole_704_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386937.286019780673087, 5861843.21080310922116 ], [ 1386898.873729433864355, 5861811.579112778417766 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E78", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 739.60003662109375, "elevtn_dn": 755.20001220703125, "invlev_up": 737.10003662109375, "invlev_dn": 752.70001220703125, "manhole_up": "manhole_704_generated", "manhole_dn": "manhole_705_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386898.873729433864355, 5861811.579112778417766 ], [ 1386860.461439087055624, 5861779.947422447614372 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E79", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 755.20001220703125, "elevtn_dn": 745.29998779296875, "invlev_up": 752.70001220703125, "invlev_dn": 742.79998779296875, "manhole_up": "manhole_705_generated", "manhole_dn": "manhole_706_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386860.461439087055624, 5861779.947422447614372 ], [ 1386822.049148740014061, 5861748.315732115879655 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E80", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 745.29998779296875, "elevtn_dn": 745.29998779296875, "invlev_up": 742.79998779296875, "invlev_dn": 742.79998779296875, "manhole_up": "manhole_706_generated", "manhole_dn": "manhole_707_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386822.049148740014061, 5861748.315732115879655 ], [ 1386774.418702265014872, 5861733.958941764198244 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E81", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 745.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 742.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_707_generated", "manhole_dn": "manhole_708_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386774.418702265014872, 5861733.958941764198244 ], [ 1386726.75721522886306, 5861719.660321676172316 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E82", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_708_generated", "manhole_dn": "manhole_709_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386726.75721522886306, 5861719.660321676172316 ], [ 1386681.211287560872734, 5861700.510515534318984 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E83", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 777.9000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_709_generated", "manhole_dn": "manhole_710_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386681.211287560872734, 5861700.510515534318984 ], [ 1386655.081909105414525, 5861659.807657876051962 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E84", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 758.79998779296875, "invlev_up": 775.4000244140625, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_710_generated", "manhole_dn": "manhole_711_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386655.081909105414525, 5861659.807657876051962 ], [ 1386647.41175345890224, 5861610.757949161343277 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E85", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_711_generated", "manhole_dn": "manhole_712_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386647.41175345890224, 5861610.757949161343277 ], [ 1386641.745189253240824, 5861561.363539570011199 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E86", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 732.4000244140625, "invlev_up": 756.29998779296875, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_712_generated", "manhole_dn": "manhole_713_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386641.745189253240824, 5861561.363539570011199 ], [ 1386642.37134926696308, 5861511.607376066967845 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E87", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_713_generated", "manhole_dn": "manhole_714_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386642.37134926696308, 5861511.607376066967845 ], [ 1386642.997509280918166, 5861461.851212563924491 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E88", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_714_generated", "manhole_dn": "manhole_715_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386642.997509280918166, 5861461.851212563924491 ], [ 1386643.623669294640422, 5861412.09504906181246 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_34_E89", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_34", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_34", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 724.29998779296875, "invlev_up": 729.9000244140625, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_715_generated", "manhole_dn": "" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386643.623669294640422, 5861412.09504906181246 ], [ 1386648.271799877518788, 5861347.644815167412162 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_35_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_35", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_35", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_716_generated", "manhole_dn": "manhole_717_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386060.978602184914052, 5859873.390328846871853 ], [ 1386078.54455375042744, 5859857.065600479952991 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_35_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_35", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_35", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_717_generated", "manhole_dn": "manhole_718_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386078.54455375042744, 5859857.065600479952991 ], [ 1386079.86695942771621, 5859885.500408614054322 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_36_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_36", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_36", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_719_generated", "manhole_dn": "manhole_716_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386030.926458492642269, 5859869.881591100245714 ], [ 1386060.978602184914052, 5859873.390328846871853 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_37_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_37", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_37", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 780.79998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 778.29998779296875, "manhole_up": "manhole_720_generated", "manhole_dn": "manhole_716_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386043.381105761509389, 5859908.11929196305573 ], [ 1386060.978602184914052, 5859873.390328846871853 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_38_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_38", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_718_generated", "manhole_dn": "manhole_721_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386079.86695942771621, 5859885.500408614054322 ], [ 1386081.40363402524963, 5859934.756705570034683 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_38_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_38", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_721_generated", "manhole_dn": "manhole_722_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386081.40363402524963, 5859934.756705570034683 ], [ 1386080.471781946951523, 5859983.948014200665057 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_38_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_38", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_38", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 756.5, "invlev_up": 763.79998779296875, "invlev_dn": 754.0, "manhole_up": "manhole_722_generated", "manhole_dn": "manhole_723_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386080.471781946951523, 5859983.948014200665057 ], [ 1386081.101269942475483, 5860033.01989212166518 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_39_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_39", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.79998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 778.29998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_718_generated", "manhole_dn": "manhole_724_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386079.86695942771621, 5859885.500408614054322 ], [ 1386051.415038994979113, 5859913.714703594334424 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_39_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_39", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_724_generated", "manhole_dn": "manhole_725_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386051.415038994979113, 5859913.714703594334424 ], [ 1386056.753747603856027, 5859949.43277302198112 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_39_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_39", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 766.29998779296875, "invlev_up": 763.79998779296875, "invlev_dn": 763.79998779296875, "manhole_up": "manhole_725_generated", "manhole_dn": "manhole_726_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386056.753747603856027, 5859949.43277302198112 ], [ 1386070.153564189793542, 5859990.873222404159606 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_39_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_39", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_39", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 766.29998779296875, "elevtn_dn": 756.5, "invlev_up": 763.79998779296875, "invlev_dn": 754.0, "manhole_up": "manhole_726_generated", "manhole_dn": "manhole_723_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386070.153564189793542, 5859990.873222404159606 ], [ 1386081.101269942475483, 5860033.01989212166518 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.5, "elevtn_dn": 756.5, "invlev_up": 754.0, "invlev_dn": 754.0, "manhole_up": "manhole_723_generated", "manhole_dn": "manhole_727_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386081.101269942475483, 5860033.01989212166518 ], [ 1386095.159510504920036, 5860079.476792480796576 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.5, "elevtn_dn": 720.29998779296875, "invlev_up": 754.0, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_727_generated", "manhole_dn": "manhole_728_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386095.159510504920036, 5860079.476792480796576 ], [ 1386119.249574675457552, 5860122.285581497475505 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_728_generated", "manhole_dn": "manhole_729_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386119.249574675457552, 5860122.285581497475505 ], [ 1386143.813145637512207, 5860164.822058788500726 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 732.5, "invlev_up": 717.79998779296875, "invlev_dn": 730.0, "manhole_up": "manhole_729_generated", "manhole_dn": "manhole_730_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386143.813145637512207, 5860164.822058788500726 ], [ 1386168.698389830067754, 5860207.173543182201684 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.5, "elevtn_dn": 732.5, "invlev_up": 730.0, "invlev_dn": 730.0, "manhole_up": "manhole_730_generated", "manhole_dn": "manhole_731_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386168.698389830067754, 5860207.173543182201684 ], [ 1386190.960878706537187, 5860250.914158629253507 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.5, "elevtn_dn": 720.29998779296875, "invlev_up": 730.0, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_731_generated", "manhole_dn": "manhole_732_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386190.960878706537187, 5860250.914158629253507 ], [ 1386212.013376480899751, 5860295.295640649273992 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 729.10003662109375, "invlev_up": 717.79998779296875, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_732_generated", "manhole_dn": "manhole_733_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386212.013376480899751, 5860295.295640649273992 ], [ 1386233.065874255495146, 5860339.677122670225799 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 729.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_733_generated", "manhole_dn": "manhole_734_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386233.065874255495146, 5860339.677122670225799 ], [ 1386254.118372030090541, 5860384.058604690246284 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E8", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 729.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 726.60003662109375, "manhole_up": "manhole_734_generated", "manhole_dn": "manhole_735_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386254.118372030090541, 5860384.058604690246284 ], [ 1386270.265550139825791, 5860430.368606903590262 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E9", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 729.10003662109375, "elevtn_dn": 746.10003662109375, "invlev_up": 726.60003662109375, "invlev_dn": 743.60003662109375, "manhole_up": "manhole_735_generated", "manhole_dn": "manhole_736_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386270.265550139825791, 5860430.368606903590262 ], [ 1386284.690116602927446, 5860477.310510716401041 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E10", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 746.10003662109375, "elevtn_dn": 746.10003662109375, "invlev_up": 743.60003662109375, "invlev_dn": 743.60003662109375, "manhole_up": "manhole_736_generated", "manhole_dn": "manhole_737_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386284.690116602927446, 5860477.310510716401041 ], [ 1386295.943752367515117, 5860525.125563691370189 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E11", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 746.10003662109375, "elevtn_dn": 720.29998779296875, "invlev_up": 743.60003662109375, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_737_generated", "manhole_dn": "manhole_738_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386295.943752367515117, 5860525.125563691370189 ], [ 1386307.197388132335618, 5860572.940616665408015 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E12", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_738_generated", "manhole_dn": "manhole_739_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386307.197388132335618, 5860572.940616665408015 ], [ 1386318.451023896923289, 5860620.755669640377164 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E13", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 720.29998779296875, "invlev_up": 717.79998779296875, "invlev_dn": 717.79998779296875, "manhole_up": "manhole_739_generated", "manhole_dn": "manhole_740_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386318.451023896923289, 5860620.755669640377164 ], [ 1386329.704659661510959, 5860668.57072261441499 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E14", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 720.29998779296875, "elevtn_dn": 737.60003662109375, "invlev_up": 717.79998779296875, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_740_generated", "manhole_dn": "manhole_741_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386329.704659661510959, 5860668.57072261441499 ], [ 1386340.95829542633146, 5860716.385775589384139 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E15", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 737.60003662109375, "invlev_up": 735.10003662109375, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_741_generated", "manhole_dn": "manhole_742_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386340.95829542633146, 5860716.385775589384139 ], [ 1386352.211931190919131, 5860764.200828563421965 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E16", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 737.60003662109375, "invlev_up": 735.10003662109375, "invlev_dn": 735.10003662109375, "manhole_up": "manhole_742_generated", "manhole_dn": "manhole_743_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386352.211931190919131, 5860764.200828563421965 ], [ 1386365.771370212780312, 5860811.365820310078561 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E17", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.60003662109375, "elevtn_dn": 744.5, "invlev_up": 735.10003662109375, "invlev_dn": 742.0, "manhole_up": "manhole_743_generated", "manhole_dn": "manhole_744_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386365.771370212780312, 5860811.365820310078561 ], [ 1386381.150273493025452, 5860858.017861452884972 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E18", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 744.5, "elevtn_dn": 724.29998779296875, "invlev_up": 742.0, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_744_generated", "manhole_dn": "manhole_745_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386381.150273493025452, 5860858.017861452884972 ], [ 1386398.399082327727228, 5860903.951519219204783 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E19", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_745_generated", "manhole_dn": "manhole_746_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386398.399082327727228, 5860903.951519219204783 ], [ 1386418.211523674428463, 5860948.90027645137161 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E20", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_746_generated", "manhole_dn": "manhole_747_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386418.211523674428463, 5860948.90027645137161 ], [ 1386441.67837643600069, 5860992.033180211670697 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E21", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_747_generated", "manhole_dn": "manhole_748_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386441.67837643600069, 5860992.033180211670697 ], [ 1386465.536530936835334, 5861034.971648660488427 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E22", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.9000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 722.4000244140625, "manhole_up": "manhole_748_generated", "manhole_dn": "manhole_749_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386465.536530936835334, 5861034.971648660488427 ], [ 1386489.394685437437147, 5861077.910117109306157 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E23", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.9000244140625, "elevtn_dn": 724.29998779296875, "invlev_up": 722.4000244140625, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_749_generated", "manhole_dn": "manhole_750_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386489.394685437437147, 5861077.910117109306157 ], [ 1386513.252839938271791, 5861120.848585557192564 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E24", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_750_generated", "manhole_dn": "manhole_751_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386513.252839938271791, 5861120.848585557192564 ], [ 1386537.110994438873604, 5861163.787054006010294 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E25", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_751_generated", "manhole_dn": "manhole_752_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386537.110994438873604, 5861163.787054006010294 ], [ 1386560.969148939708248, 5861206.725522454828024 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E26", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_752_generated", "manhole_dn": "manhole_753_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386560.969148939708248, 5861206.725522454828024 ], [ 1386584.827303440310061, 5861249.663990902714431 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E27", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_753_generated", "manhole_dn": "manhole_754_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386584.827303440310061, 5861249.663990902714431 ], [ 1386607.696082097478211, 5861293.105181481689215 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E28", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_754_generated", "manhole_dn": "manhole_755_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386607.696082097478211, 5861293.105181481689215 ], [ 1386626.999141034670174, 5861338.164890616200864 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E29", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 732.4000244140625, "invlev_up": 721.79998779296875, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_755_generated", "manhole_dn": "manhole_756_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386626.999141034670174, 5861338.164890616200864 ], [ 1386632.635544582502916, 5861386.242180755361915 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E30", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_756_generated", "manhole_dn": "manhole_757_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386632.635544582502916, 5861386.242180755361915 ], [ 1386628.332881111185998, 5861435.174896763637662 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E31", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 732.4000244140625, "invlev_up": 729.9000244140625, "invlev_dn": 729.9000244140625, "manhole_up": "manhole_757_generated", "manhole_dn": "manhole_758_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386628.332881111185998, 5861435.174896763637662 ], [ 1386624.030217639869079, 5861484.107612771913409 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E32", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 732.4000244140625, "elevtn_dn": 758.79998779296875, "invlev_up": 729.9000244140625, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_758_generated", "manhole_dn": "manhole_759_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386624.030217639869079, 5861484.107612771913409 ], [ 1386619.72755416855216, 5861533.040328779257834 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E33", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_759_generated", "manhole_dn": "manhole_760_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386619.72755416855216, 5861533.040328779257834 ], [ 1386620.396809899713844, 5861581.843449912965298 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E34", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 758.79998779296875, "invlev_up": 756.29998779296875, "invlev_dn": 756.29998779296875, "manhole_up": "manhole_760_generated", "manhole_dn": "manhole_761_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386620.396809899713844, 5861581.843449912965298 ], [ 1386627.242796876933426, 5861630.485572309233248 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E35", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 758.79998779296875, "elevtn_dn": 777.9000244140625, "invlev_up": 756.29998779296875, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_761_generated", "manhole_dn": "manhole_762_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386627.242796876933426, 5861630.485572309233248 ], [ 1386633.497009602142498, 5861679.177458625286818 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E36", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 777.9000244140625, "invlev_up": 775.4000244140625, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_762_generated", "manhole_dn": "manhole_763_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386633.497009602142498, 5861679.177458625286818 ], [ 1386633.587326586712152, 5861728.232037586160004 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E37", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 777.9000244140625, "invlev_up": 775.4000244140625, "invlev_dn": 775.4000244140625, "manhole_up": "manhole_763_generated", "manhole_dn": "manhole_764_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386633.587326586712152, 5861728.232037586160004 ], [ 1386628.569951781770214, 5861777.096641942858696 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_40_E38", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_40", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_40", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.9000244140625, "elevtn_dn": 787.0, "invlev_up": 775.4000244140625, "invlev_dn": 784.5, "manhole_up": "manhole_764_generated", "manhole_dn": "manhole_765_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386628.569951781770214, 5861777.096641942858696 ], [ 1386623.552576976828277, 5861825.961246299557388 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 787.0, "elevtn_dn": 787.0, "invlev_up": 784.5, "invlev_dn": 784.5, "manhole_up": "manhole_765_generated", "manhole_dn": "manhole_766_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386623.552576976828277, 5861825.961246299557388 ], [ 1386622.452884682221338, 5861875.377415779046714 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 787.0, "elevtn_dn": 768.0, "invlev_up": 784.5, "invlev_dn": 765.5, "manhole_up": "manhole_766_generated", "manhole_dn": "manhole_767_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386622.452884682221338, 5861875.377415779046714 ], [ 1386630.050831846194342, 5861924.208797036670148 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_767_generated", "manhole_dn": "manhole_768_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386630.050831846194342, 5861924.208797036670148 ], [ 1386645.112437101313844, 5861971.295391816645861 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_768_generated", "manhole_dn": "manhole_769_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386645.112437101313844, 5861971.295391816645861 ], [ 1386663.826805545249954, 5862017.116109635680914 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 729.0, "invlev_up": 765.5, "invlev_dn": 726.5, "manhole_up": "manhole_769_generated", "manhole_dn": "manhole_770_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386663.826805545249954, 5862017.116109635680914 ], [ 1386682.541173989186063, 5862062.93682745564729 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 729.0, "invlev_up": 726.5, "invlev_dn": 726.5, "manhole_up": "manhole_770_generated", "manhole_dn": "manhole_771_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386682.541173989186063, 5862062.93682745564729 ], [ 1386700.357504795538262, 5862109.113540357910097 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 729.0, "invlev_up": 726.5, "invlev_dn": 726.5, "manhole_up": "manhole_771_generated", "manhole_dn": "manhole_772_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386700.357504795538262, 5862109.113540357910097 ], [ 1386718.120609947945923, 5862155.311352676711977 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 729.0, "elevtn_dn": 724.29998779296875, "invlev_up": 726.5, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_772_generated", "manhole_dn": "manhole_773_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386718.120609947945923, 5862155.311352676711977 ], [ 1386735.883715100120753, 5862201.509164996445179 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E8", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_773_generated", "manhole_dn": "manhole_774_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386735.883715100120753, 5862201.509164996445179 ], [ 1386757.522535112220794, 5862245.993861058726907 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E9", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_774_generated", "manhole_dn": "manhole_775_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386757.522535112220794, 5862245.993861058726907 ], [ 1386779.73098383564502, 5862290.226773838512599 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E10", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_775_generated", "manhole_dn": "manhole_776_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386779.73098383564502, 5862290.226773838512599 ], [ 1386802.545179207576439, 5862334.095372994430363 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E11", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 724.29998779296875, "invlev_up": 721.79998779296875, "invlev_dn": 721.79998779296875, "manhole_up": "manhole_776_generated", "manhole_dn": "manhole_777_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386802.545179207576439, 5862334.095372994430363 ], [ 1386831.207993831252679, 5862374.446442689746618 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E12", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 724.29998779296875, "elevtn_dn": 737.70001220703125, "invlev_up": 721.79998779296875, "invlev_dn": 735.20001220703125, "manhole_up": "manhole_777_generated", "manhole_dn": "manhole_778_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386831.207993831252679, 5862374.446442689746618 ], [ 1386859.988485741894692, 5862414.708453865721822 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E13", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.70001220703125, "elevtn_dn": 737.70001220703125, "invlev_up": 735.20001220703125, "invlev_dn": 735.20001220703125, "manhole_up": "manhole_778_generated", "manhole_dn": "manhole_779_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386859.988485741894692, 5862414.708453865721822 ], [ 1386891.035651177866384, 5862453.255039785988629 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E14", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 737.70001220703125, "elevtn_dn": 743.9000244140625, "invlev_up": 735.20001220703125, "invlev_dn": 741.4000244140625, "manhole_up": "manhole_779_generated", "manhole_dn": "manhole_780_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386891.035651177866384, 5862453.255039785988629 ], [ 1386922.082816614070907, 5862491.801625707186759 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E15", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 743.9000244140625, "elevtn_dn": 756.0, "invlev_up": 741.4000244140625, "invlev_dn": 753.5, "manhole_up": "manhole_780_generated", "manhole_dn": "manhole_781_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386922.082816614070907, 5862491.801625707186759 ], [ 1386953.12998205027543, 5862530.348211627453566 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E16", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.0, "elevtn_dn": 756.0, "invlev_up": 753.5, "invlev_dn": 753.5, "manhole_up": "manhole_781_generated", "manhole_dn": "manhole_782_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386953.12998205027543, 5862530.348211627453566 ], [ 1386984.177147486479953, 5862568.894797547720373 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E17", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 756.0, "elevtn_dn": 761.4000244140625, "invlev_up": 753.5, "invlev_dn": 758.9000244140625, "manhole_up": "manhole_782_generated", "manhole_dn": "manhole_783_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1386984.177147486479953, 5862568.894797547720373 ], [ 1387010.83190148579888, 5862610.297833287157118 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E18", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.4000244140625, "elevtn_dn": 761.4000244140625, "invlev_up": 758.9000244140625, "invlev_dn": 758.9000244140625, "manhole_up": "manhole_783_generated", "manhole_dn": "manhole_784_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387010.83190148579888, 5862610.297833287157118 ], [ 1387033.474099110113457, 5862654.310293504968286 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E19", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 761.4000244140625, "elevtn_dn": 770.5, "invlev_up": 758.9000244140625, "invlev_dn": 768.0, "manhole_up": "manhole_784_generated", "manhole_dn": "manhole_785_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387033.474099110113457, 5862654.310293504968286 ], [ 1387056.116296734428033, 5862698.322753723710775 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E20", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 770.5, "elevtn_dn": 765.29998779296875, "invlev_up": 768.0, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_785_generated", "manhole_dn": "manhole_786_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387056.116296734428033, 5862698.322753723710775 ], [ 1387078.75849435874261, 5862742.335213942453265 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E21", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 765.29998779296875, "invlev_up": 762.79998779296875, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_786_generated", "manhole_dn": "manhole_787_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387078.75849435874261, 5862742.335213942453265 ], [ 1387101.400691983057186, 5862786.347674161195755 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E22", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 765.29998779296875, "invlev_up": 762.79998779296875, "invlev_dn": 762.79998779296875, "manhole_up": "manhole_787_generated", "manhole_dn": "manhole_788_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387101.400691983057186, 5862786.347674161195755 ], [ 1387124.783531384309754, 5862829.966971693560481 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E23", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 765.29998779296875, "elevtn_dn": 764.20001220703125, "invlev_up": 762.79998779296875, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_788_generated", "manhole_dn": "manhole_789_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387124.783531384309754, 5862829.966971693560481 ], [ 1387148.551342260092497, 5862873.381910757161677 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E24", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 764.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_789_generated", "manhole_dn": "manhole_790_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387148.551342260092497, 5862873.381910757161677 ], [ 1387176.029596295906231, 5862914.516764627769589 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E25", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 764.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 761.70001220703125, "manhole_up": "manhole_790_generated", "manhole_dn": "manhole_791_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387176.029596295906231, 5862914.516764627769589 ], [ 1387204.050833505578339, 5862955.315435893833637 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E26", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 764.20001220703125, "elevtn_dn": 769.20001220703125, "invlev_up": 761.70001220703125, "invlev_dn": 766.70001220703125, "manhole_up": "manhole_791_generated", "manhole_dn": "manhole_792_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387204.050833505578339, 5862955.315435893833637 ], [ 1387233.152246462181211, 5862995.351338926702738 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E27", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 769.20001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 766.70001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_792_generated", "manhole_dn": "manhole_793_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387233.152246462181211, 5862995.351338926702738 ], [ 1387262.253659419016913, 5863035.387241959571838 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E28", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 770.20001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_793_generated", "manhole_dn": "manhole_794_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387262.253659419016913, 5863035.387241959571838 ], [ 1387289.177211825968698, 5863076.714860137552023 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E29", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 772.70001220703125, "invlev_up": 770.20001220703125, "invlev_dn": 770.20001220703125, "manhole_up": "manhole_794_generated", "manhole_dn": "manhole_795_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387289.177211825968698, 5863076.714860137552023 ], [ 1387304.666786204557866, 5863123.392671256326139 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E30", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 772.70001220703125, "elevtn_dn": 762.0, "invlev_up": 770.20001220703125, "invlev_dn": 759.5, "manhole_up": "manhole_795_generated", "manhole_dn": "manhole_796_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387304.666786204557866, 5863123.392671256326139 ], [ 1387314.520281337434426, 5863171.895173518918455 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E31", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 777.10003662109375, "invlev_up": 759.5, "invlev_dn": 774.60003662109375, "manhole_up": "manhole_796_generated", "manhole_dn": "manhole_797_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387314.520281337434426, 5863171.895173518918455 ], [ 1387324.142220750683919, 5863220.446013364940882 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E32", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.10003662109375, "elevtn_dn": 780.4000244140625, "invlev_up": 774.60003662109375, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_797_generated", "manhole_dn": "manhole_798_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387324.142220750683919, 5863220.446013364940882 ], [ 1387333.764160163700581, 5863268.996853210031986 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E33", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 780.4000244140625, "invlev_up": 777.9000244140625, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_798_generated", "manhole_dn": "manhole_799_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387333.764160163700581, 5863268.996853210031986 ], [ 1387343.386099576717243, 5863317.547693055123091 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E34", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 780.4000244140625, "invlev_up": 777.9000244140625, "invlev_dn": 777.9000244140625, "manhole_up": "manhole_799_generated", "manhole_dn": "manhole_800_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387343.386099576717243, 5863317.547693055123091 ], [ 1387353.008038989733905, 5863366.098532900214195 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E35", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 780.4000244140625, "elevtn_dn": 762.0, "invlev_up": 777.9000244140625, "invlev_dn": 759.5, "manhole_up": "manhole_800_generated", "manhole_dn": "manhole_801_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387353.008038989733905, 5863366.098532900214195 ], [ 1387364.066297837067395, 5863414.311534740030766 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E36", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_801_generated", "manhole_dn": "manhole_802_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387364.066297837067395, 5863414.311534740030766 ], [ 1387381.839409928303212, 5863460.427046488039196 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E37", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_802_generated", "manhole_dn": "manhole_803_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387381.839409928303212, 5863460.427046488039196 ], [ 1387403.429578960640356, 5863504.96100580971688 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E38", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_803_generated", "manhole_dn": "manhole_804_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387403.429578960640356, 5863504.96100580971688 ], [ 1387425.140452897874638, 5863549.440256260335445 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E39", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_804_generated", "manhole_dn": "manhole_805_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387425.140452897874638, 5863549.440256260335445 ], [ 1387446.851326835108921, 5863593.91950671095401 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E40", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_805_generated", "manhole_dn": "manhole_806_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387446.851326835108921, 5863593.91950671095401 ], [ 1387467.528695637593046, 5863638.888379830867052 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E41", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 774.5, "invlev_up": 759.5, "invlev_dn": 772.0, "manhole_up": "manhole_806_generated", "manhole_dn": "manhole_807_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387467.528695637593046, 5863638.888379830867052 ], [ 1387488.196078018052503, 5863683.861984014511108 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E42", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 774.5, "elevtn_dn": 762.0, "invlev_up": 772.0, "invlev_dn": 759.5, "manhole_up": "manhole_807_generated", "manhole_dn": "manhole_808_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387488.196078018052503, 5863683.861984014511108 ], [ 1387508.863468252588063, 5863728.835584589280188 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E43", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_808_generated", "manhole_dn": "manhole_809_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387508.863468252588063, 5863728.835584589280188 ], [ 1387529.53130904212594, 5863773.808978110551834 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E44", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_809_generated", "manhole_dn": "manhole_810_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387529.53130904212594, 5863773.808978110551834 ], [ 1387553.168002701364458, 5863817.17347530182451 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E45", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_810_generated", "manhole_dn": "manhole_811_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387553.168002701364458, 5863817.17347530182451 ], [ 1387579.562712850514799, 5863859.043333718553185 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E46", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 777.0, "invlev_up": 759.5, "invlev_dn": 774.5, "manhole_up": "manhole_811_generated", "manhole_dn": "manhole_812_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387579.562712850514799, 5863859.043333718553185 ], [ 1387605.957422999665141, 5863900.913192136213183 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E47", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.0, "elevtn_dn": 762.0, "invlev_up": 774.5, "invlev_dn": 759.5, "manhole_up": "manhole_812_generated", "manhole_dn": "manhole_813_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387605.957422999665141, 5863900.913192136213183 ], [ 1387632.352133149048313, 5863942.783050553873181 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E48", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_813_generated", "manhole_dn": "manhole_814_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387632.352133149048313, 5863942.783050553873181 ], [ 1387658.746843298198655, 5863984.652908970601857 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E49", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_814_generated", "manhole_dn": "manhole_815_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387658.746843298198655, 5863984.652908970601857 ], [ 1387685.893106181640178, 5864026.029537551105022 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E50", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_815_generated", "manhole_dn": "manhole_816_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387685.893106181640178, 5864026.029537551105022 ], [ 1387711.231136992340907, 5864068.42725711222738 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E51", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_816_generated", "manhole_dn": "manhole_817_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387711.231136992340907, 5864068.42725711222738 ], [ 1387731.020947323646396, 5864113.414904261007905 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E52", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_817_generated", "manhole_dn": "manhole_818_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387731.020947323646396, 5864113.414904261007905 ], [ 1387737.361907477490604, 5864162.342261835932732 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E53", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_818_generated", "manhole_dn": "manhole_819_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387737.361907477490604, 5864162.342261835932732 ], [ 1387732.727565656881779, 5864211.475179814733565 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E54", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_819_generated", "manhole_dn": "manhole_820_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387732.727565656881779, 5864211.475179814733565 ], [ 1387717.67884943424724, 5864258.627082298509777 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E55", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 762.0, "invlev_up": 759.5, "invlev_dn": 759.5, "manhole_up": "manhole_820_generated", "manhole_dn": "manhole_821_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387717.67884943424724, 5864258.627082298509777 ], [ 1387709.67210421175696, 5864307.23127611912787 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E56", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 762.0, "elevtn_dn": 768.0, "invlev_up": 759.5, "invlev_dn": 765.5, "manhole_up": "manhole_821_generated", "manhole_dn": "manhole_822_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387709.67210421175696, 5864307.23127611912787 ], [ 1387707.11288084089756, 5864356.66017600055784 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E57", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_822_generated", "manhole_dn": "manhole_823_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387707.11288084089756, 5864356.66017600055784 ], [ 1387709.591797993984073, 5864406.012949175201356 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E58", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 768.0, "invlev_up": 765.5, "invlev_dn": 765.5, "manhole_up": "manhole_823_generated", "manhole_dn": "manhole_824_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387709.591797993984073, 5864406.012949175201356 ], [ 1387713.643261310644448, 5864455.341961052268744 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E59", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 768.0, "elevtn_dn": 777.20001220703125, "invlev_up": 765.5, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_824_generated", "manhole_dn": "manhole_825_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387713.643261310644448, 5864455.341961052268744 ], [ 1387715.877521668095142, 5864504.642317942343652 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E60", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 774.70001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_825_generated", "manhole_dn": "manhole_826_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387715.877521668095142, 5864504.642317942343652 ], [ 1387708.68023270717822, 5864553.426558391191065 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E61", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 777.20001220703125, "invlev_up": 774.70001220703125, "invlev_dn": 774.70001220703125, "manhole_up": "manhole_826_generated", "manhole_dn": "manhole_827_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387708.68023270717822, 5864553.426558391191065 ], [ 1387690.790250770282, 5864599.575386263430119 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E62", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 777.20001220703125, "elevtn_dn": 810.60003662109375, "invlev_up": 774.70001220703125, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_827_generated", "manhole_dn": "manhole_828_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387690.790250770282, 5864599.575386263430119 ], [ 1387672.900268833618611, 5864645.724214136600494 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E63", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 810.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_828_generated", "manhole_dn": "manhole_829_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387672.900268833618611, 5864645.724214136600494 ], [ 1387659.931900478899479, 5864692.98388583958149 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E64", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 810.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 808.10003662109375, "manhole_up": "manhole_829_generated", "manhole_dn": "manhole_830_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387659.931900478899479, 5864692.98388583958149 ], [ 1387659.223570322152227, 5864742.029465307481587 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E65", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 810.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 808.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_830_generated", "manhole_dn": "manhole_831_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387659.223570322152227, 5864742.029465307481587 ], [ 1387675.926896508783102, 5864788.273513910360634 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E66", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 774.10003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 771.60003662109375, "manhole_up": "manhole_831_generated", "manhole_dn": "manhole_832_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387675.926896508783102, 5864788.273513910360634 ], [ 1387702.296291569946334, 5864830.159320239908993 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E67", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 774.10003662109375, "elevtn_dn": 774.10003662109375, "invlev_up": 771.60003662109375, "invlev_dn": 771.60003662109375, "manhole_up": "manhole_832_generated", "manhole_dn": "manhole_833_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387702.296291569946334, 5864830.159320239908993 ], [ 1387728.665686630876735, 5864872.045126569457352 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E68", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 774.10003662109375, "elevtn_dn": 782.5, "invlev_up": 771.60003662109375, "invlev_dn": 780.0, "manhole_up": "manhole_833_generated", "manhole_dn": "manhole_834_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387728.665686630876735, 5864872.045126569457352 ], [ 1387751.608185108983889, 5864915.528788692317903 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E69", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 782.5, "invlev_up": 780.0, "invlev_dn": 780.0, "manhole_up": "manhole_834_generated", "manhole_dn": "manhole_835_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387751.608185108983889, 5864915.528788692317903 ], [ 1387766.741664502769709, 5864962.653554677963257 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E70", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 782.5, "invlev_up": 780.0, "invlev_dn": 780.0, "manhole_up": "manhole_835_generated", "manhole_dn": "manhole_836_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387766.741664502769709, 5864962.653554677963257 ], [ 1387778.99191950308159, 5865010.246724016033113 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E71", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 782.5, "elevtn_dn": 820.20001220703125, "invlev_up": 780.0, "invlev_dn": 817.70001220703125, "manhole_up": "manhole_836_generated", "manhole_dn": "manhole_837_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387778.99191950308159, 5865010.246724016033113 ], [ 1387779.554608268430457, 5865059.738633952103555 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E72", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 820.20001220703125, "elevtn_dn": 820.20001220703125, "invlev_up": 817.70001220703125, "invlev_dn": 817.70001220703125, "manhole_up": "manhole_837_generated", "manhole_dn": "manhole_838_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387779.554608268430457, 5865059.738633952103555 ], [ 1387780.117297033779323, 5865109.230543887242675 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E73", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 820.20001220703125, "elevtn_dn": 834.60003662109375, "invlev_up": 817.70001220703125, "invlev_dn": 832.10003662109375, "manhole_up": "manhole_838_generated", "manhole_dn": "manhole_839_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387780.117297033779323, 5865109.230543887242675 ], [ 1387782.917817069217563, 5865158.566991245374084 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E74", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 834.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 832.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_839_generated", "manhole_dn": "manhole_840_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387782.917817069217563, 5865158.566991245374084 ], [ 1387789.203931836877018, 5865207.661293652839959 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E75", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 809.60003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 807.10003662109375, "manhole_up": "manhole_840_generated", "manhole_dn": "manhole_841_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387789.203931836877018, 5865207.661293652839959 ], [ 1387795.490046604769304, 5865256.755596060305834 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E76", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 809.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 807.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_841_generated", "manhole_dn": "manhole_842_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387795.490046604769304, 5865256.755596060305834 ], [ 1387804.549934879876673, 5865305.332479531876743 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E77", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 809.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_842_generated", "manhole_dn": "manhole_843_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387804.549934879876673, 5865305.332479531876743 ], [ 1387816.386747075244784, 5865353.391356389038265 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E78", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 811.60003662109375, "invlev_up": 809.10003662109375, "invlev_dn": 809.10003662109375, "manhole_up": "manhole_843_generated", "manhole_dn": "manhole_844_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387816.386747075244784, 5865353.391356389038265 ], [ 1387828.223559270845726, 5865401.450233246199787 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E79", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 811.60003662109375, "elevtn_dn": 802.5, "invlev_up": 809.10003662109375, "invlev_dn": 800.0, "manhole_up": "manhole_844_generated", "manhole_dn": "manhole_845_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387828.223559270845726, 5865401.450233246199787 ], [ 1387842.96627543354407, 5865448.679594250395894 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E80", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 802.5, "invlev_up": 800.0, "invlev_dn": 800.0, "manhole_up": "manhole_845_generated", "manhole_dn": "manhole_846_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387842.96627543354407, 5865448.679594250395894 ], [ 1387858.283513206522912, 5865495.744953005574644 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E81", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 802.5, "invlev_up": 800.0, "invlev_dn": 800.0, "manhole_up": "manhole_846_generated", "manhole_dn": "manhole_847_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387858.283513206522912, 5865495.744953005574644 ], [ 1387872.788357679266483, 5865543.026506381109357 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E82", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 802.5, "elevtn_dn": 778.20001220703125, "invlev_up": 800.0, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_847_generated", "manhole_dn": "manhole_848_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387872.788357679266483, 5865543.026506381109357 ], [ 1387882.890574953285977, 5865591.479689701460302 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E83", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_848_generated", "manhole_dn": "manhole_849_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387882.890574953285977, 5865591.479689701460302 ], [ 1387892.992792227305472, 5865639.932873022742569 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E84", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_849_generated", "manhole_dn": "manhole_850_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387892.992792227305472, 5865639.932873022742569 ], [ 1387903.095009501324967, 5865688.386056343093514 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_41_E85", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_41", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_41", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_850_generated", "manhole_dn": "manhole_851_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387903.095009501324967, 5865688.386056343093514 ], [ 1387913.197226775344461, 5865736.839239663444459 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_42_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 830.9000244140625, "invlev_up": 828.4000244140625, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_852_generated", "manhole_dn": "manhole_853_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387767.438602478476241, 5866395.894650792703032 ], [ 1387758.181959156645462, 5866444.388786932453513 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_42_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 830.9000244140625, "invlev_up": 828.4000244140625, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_853_generated", "manhole_dn": "manhole_854_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387758.181959156645462, 5866444.388786932453513 ], [ 1387748.925315835047513, 5866492.882923071272671 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_42_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 816.5, "invlev_up": 828.4000244140625, "invlev_dn": 814.0, "manhole_up": "manhole_854_generated", "manhole_dn": "manhole_855_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387748.925315835047513, 5866492.882923071272671 ], [ 1387739.668672513216734, 5866541.377059211023152 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_42_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.5, "elevtn_dn": 816.5, "invlev_up": 814.0, "invlev_dn": 814.0, "manhole_up": "manhole_855_generated", "manhole_dn": "manhole_856_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387739.668672513216734, 5866541.377059211023152 ], [ 1387730.412029191618785, 5866589.87119534984231 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_42_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.5, "elevtn_dn": 816.10003662109375, "invlev_up": 814.0, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_856_generated", "manhole_dn": "manhole_857_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387730.412029191618785, 5866589.87119534984231 ], [ 1387721.155385869788006, 5866638.365331489592791 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_42_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 816.10003662109375, "invlev_up": 813.60003662109375, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_857_generated", "manhole_dn": "manhole_858_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387721.155385869788006, 5866638.365331489592791 ], [ 1387711.868742506252602, 5866686.853722332976758 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_42_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 816.10003662109375, "invlev_up": 813.60003662109375, "invlev_dn": 813.60003662109375, "manhole_up": "manhole_858_generated", "manhole_dn": "manhole_859_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387711.868742506252602, 5866686.853722332976758 ], [ 1387702.553355348296463, 5866735.336608462966979 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_42_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_42", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_42", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.10003662109375, "elevtn_dn": 802.4000244140625, "invlev_up": 813.60003662109375, "invlev_dn": 799.9000244140625, "manhole_up": "manhole_859_generated", "manhole_dn": "manhole_860_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387702.553355348296463, 5866735.336608462966979 ], [ 1387692.161796326050535, 5866783.420620376244187 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_43_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_43", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_43", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_861_generated", "manhole_dn": "manhole_862_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387809.534624515566975, 5866309.639251782558858 ], [ 1387788.486613497138023, 5866352.766951287165284 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_43_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_43", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_43", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 830.9000244140625, "invlev_up": 803.70001220703125, "invlev_dn": 828.4000244140625, "manhole_up": "manhole_862_generated", "manhole_dn": "manhole_852_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387788.486613497138023, 5866352.766951287165284 ], [ 1387767.438602478476241, 5866395.894650792703032 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_44_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 830.9000244140625, "elevtn_dn": 840.10003662109375, "invlev_up": 828.4000244140625, "invlev_dn": 837.60003662109375, "manhole_up": "manhole_852_generated", "manhole_dn": "manhole_863_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387767.438602478476241, 5866395.894650792703032 ], [ 1387774.73306847945787, 5866351.644692087545991 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_44_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 840.10003662109375, "elevtn_dn": 806.20001220703125, "invlev_up": 837.60003662109375, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_863_generated", "manhole_dn": "manhole_864_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387774.73306847945787, 5866351.644692087545991 ], [ 1387787.219046234386042, 5866308.756401930935681 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_44_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_864_generated", "manhole_dn": "manhole_865_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387787.219046234386042, 5866308.756401930935681 ], [ 1387802.581935805035755, 5866266.622689731419086 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_44_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_865_generated", "manhole_dn": "manhole_866_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387802.581935805035755, 5866266.622689731419086 ], [ 1387818.989883717847988, 5866224.886323318816721 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_44_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_866_generated", "manhole_dn": "manhole_867_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387818.989883717847988, 5866224.886323318816721 ], [ 1387838.767447788733989, 5866184.784887914545834 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_44_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_867_generated", "manhole_dn": "manhole_868_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387838.767447788733989, 5866184.784887914545834 ], [ 1387862.375427621416748, 5866146.679679537191987 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_44_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 803.9000244140625, "invlev_up": 825.20001220703125, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_868_generated", "manhole_dn": "manhole_869_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387862.375427621416748, 5866146.679679537191987 ], [ 1387890.316308293025941, 5866111.904927220195532 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_44_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_44", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_44", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_869_generated", "manhole_dn": "manhole_870_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387890.316308293025941, 5866111.904927220195532 ], [ 1387932.086585889104754, 5866099.149365295656025 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_45_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_45", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_871_generated", "manhole_dn": "manhole_872_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387931.614702571649104, 5866170.542120457626879 ], [ 1387899.497387683717534, 5866203.806988564319909 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_45_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_45", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 806.20001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_872_generated", "manhole_dn": "manhole_873_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387899.497387683717534, 5866203.806988564319909 ], [ 1387869.509799961000681, 5866239.084409636445343 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_45_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_45", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_873_generated", "manhole_dn": "manhole_874_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387869.509799961000681, 5866239.084409636445343 ], [ 1387839.522212238283828, 5866274.361830709502101 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_45_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_45", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_45", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_874_generated", "manhole_dn": "manhole_861_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387839.522212238283828, 5866274.361830709502101 ], [ 1387809.534624515566975, 5866309.639251782558858 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_46_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_46", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_870_generated", "manhole_dn": "manhole_875_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387932.086585889104754, 5866099.149365295656025 ], [ 1387908.367353544337675, 5866141.903963415883482 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_46_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_46", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_875_generated", "manhole_dn": "manhole_876_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387908.367353544337675, 5866141.903963415883482 ], [ 1387876.955022902460769, 5866179.987773489207029 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_46_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_46", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 827.70001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_876_generated", "manhole_dn": "manhole_877_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387876.955022902460769, 5866179.987773489207029 ], [ 1387847.458594153402373, 5866219.470102892257273 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_46_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_46", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_877_generated", "manhole_dn": "manhole_878_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387847.458594153402373, 5866219.470102892257273 ], [ 1387823.639855962945148, 5866262.662997540086508 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_46_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_46", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_46", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 806.20001220703125, "elevtn_dn": 806.20001220703125, "invlev_up": 803.70001220703125, "invlev_dn": 803.70001220703125, "manhole_up": "manhole_878_generated", "manhole_dn": "manhole_861_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387823.639855962945148, 5866262.662997540086508 ], [ 1387809.534624515566975, 5866309.639251782558858 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_47_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_47", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_879_generated", "manhole_dn": "manhole_880_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.443674022099003, 5865845.093254727311432 ], [ 1387943.318034203490242, 5865887.628139751963317 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_47_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_47", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_880_generated", "manhole_dn": "manhole_881_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387943.318034203490242, 5865887.628139751963317 ], [ 1387946.009428307646886, 5865930.175072746351361 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_47_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_47", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 816.70001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_881_generated", "manhole_dn": "manhole_882_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387946.009428307646886, 5865930.175072746351361 ], [ 1387948.700822412036359, 5865972.722005739808083 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_47_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_47", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_882_generated", "manhole_dn": "manhole_883_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387948.700822412036359, 5865972.722005739808083 ], [ 1387944.872250664513558, 5866015.105105520226061 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_47_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_47", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_883_generated", "manhole_dn": "manhole_884_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387944.872250664513558, 5866015.105105520226061 ], [ 1387940.047370131826028, 5866057.463170127011836 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_47_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_47", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_47", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 803.9000244140625, "invlev_up": 814.20001220703125, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_884_generated", "manhole_dn": "manhole_870_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387940.047370131826028, 5866057.463170127011836 ], [ 1387932.086585889104754, 5866099.149365295656025 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_48_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_48", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_48", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 786.29998779296875, "invlev_up": 801.4000244140625, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_870_generated", "manhole_dn": "manhole_885_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387932.086585889104754, 5866099.149365295656025 ], [ 1387975.279995472636074, 5866107.425722245126963 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E125", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 909.5, "elevtn_dn": 910.4000244140625, "invlev_up": 907.0, "invlev_dn": 907.9000244140625, "manhole_up": "manhole_886_generated", "manhole_dn": "manhole_887_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392926.966794768813998, 5866808.501405037939548 ], [ 1392879.417931769276038, 5866793.491589142940938 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E126", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 910.4000244140625, "elevtn_dn": 910.4000244140625, "invlev_up": 907.9000244140625, "invlev_dn": 907.9000244140625, "manhole_up": "manhole_887_generated", "manhole_dn": "manhole_888_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392879.417931769276038, 5866793.491589142940938 ], [ 1392831.869068769738078, 5866778.481773247942328 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E127", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 910.4000244140625, "elevtn_dn": 865.0, "invlev_up": 907.9000244140625, "invlev_dn": 862.5, "manhole_up": "manhole_888_generated", "manhole_dn": "manhole_889_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392831.869068769738078, 5866778.481773247942328 ], [ 1392784.320205770200118, 5866763.471957352943718 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E128", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 865.0, "elevtn_dn": 865.0, "invlev_up": 862.5, "invlev_dn": 862.5, "manhole_up": "manhole_889_generated", "manhole_dn": "manhole_890_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392784.320205770200118, 5866763.471957352943718 ], [ 1392736.771342770429328, 5866748.462141457945108 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E129", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 865.0, "elevtn_dn": 878.4000244140625, "invlev_up": 862.5, "invlev_dn": 875.9000244140625, "manhole_up": "manhole_890_generated", "manhole_dn": "manhole_891_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392736.771342770429328, 5866748.462141457945108 ], [ 1392689.222479770891368, 5866733.452325562946498 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E130", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 878.4000244140625, "elevtn_dn": 878.4000244140625, "invlev_up": 875.9000244140625, "invlev_dn": 875.9000244140625, "manhole_up": "manhole_891_generated", "manhole_dn": "manhole_892_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392689.222479770891368, 5866733.452325562946498 ], [ 1392641.673616771353409, 5866718.442509667947888 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E131", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 878.4000244140625, "elevtn_dn": 904.9000244140625, "invlev_up": 875.9000244140625, "invlev_dn": 902.4000244140625, "manhole_up": "manhole_892_generated", "manhole_dn": "manhole_893_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392641.673616771353409, 5866718.442509667947888 ], [ 1392594.124753771815449, 5866703.432693773880601 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E132", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 904.9000244140625, "elevtn_dn": 904.9000244140625, "invlev_up": 902.4000244140625, "invlev_dn": 902.4000244140625, "manhole_up": "manhole_893_generated", "manhole_dn": "manhole_894_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392594.124753771815449, 5866703.432693773880601 ], [ 1392546.575890772277489, 5866688.422877878881991 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E133", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 904.9000244140625, "elevtn_dn": 931.5, "invlev_up": 902.4000244140625, "invlev_dn": 929.0, "manhole_up": "manhole_894_generated", "manhole_dn": "manhole_895_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392546.575890772277489, 5866688.422877878881991 ], [ 1392499.02702777273953, 5866673.413061983883381 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E134", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 931.5, "elevtn_dn": 931.5, "invlev_up": 929.0, "invlev_dn": 929.0, "manhole_up": "manhole_895_generated", "manhole_dn": "manhole_896_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392499.02702777273953, 5866673.413061983883381 ], [ 1392451.47816477320157, 5866658.403246088884771 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E135", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 931.5, "elevtn_dn": 926.29998779296875, "invlev_up": 929.0, "invlev_dn": 923.79998779296875, "manhole_up": "manhole_896_generated", "manhole_dn": "manhole_897_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392451.47816477320157, 5866658.403246088884771 ], [ 1392403.92930177366361, 5866643.393430193886161 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E136", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 926.29998779296875, "elevtn_dn": 849.79998779296875, "invlev_up": 923.79998779296875, "invlev_dn": 847.29998779296875, "manhole_up": "manhole_897_generated", "manhole_dn": "manhole_898_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392403.92930177366361, 5866643.393430193886161 ], [ 1392356.380438774125651, 5866628.383614298887551 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E137", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 849.79998779296875, "elevtn_dn": 875.20001220703125, "invlev_up": 847.29998779296875, "invlev_dn": 872.70001220703125, "manhole_up": "manhole_898_generated", "manhole_dn": "manhole_899_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392356.380438774125651, 5866628.383614298887551 ], [ 1392308.831575774587691, 5866613.373798403888941 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E138", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 875.20001220703125, "elevtn_dn": 875.20001220703125, "invlev_up": 872.70001220703125, "invlev_dn": 872.70001220703125, "manhole_up": "manhole_899_generated", "manhole_dn": "manhole_900_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392308.831575774587691, 5866613.373798403888941 ], [ 1392261.282712775049731, 5866598.363982509821653 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E139", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 875.20001220703125, "elevtn_dn": 928.10003662109375, "invlev_up": 872.70001220703125, "invlev_dn": 925.60003662109375, "manhole_up": "manhole_900_generated", "manhole_dn": "manhole_901_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392261.282712775049731, 5866598.363982509821653 ], [ 1392213.733849775511771, 5866583.354166614823043 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E140", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 928.10003662109375, "elevtn_dn": 928.10003662109375, "invlev_up": 925.60003662109375, "invlev_dn": 925.60003662109375, "manhole_up": "manhole_901_generated", "manhole_dn": "manhole_902_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392213.733849775511771, 5866583.354166614823043 ], [ 1392166.184986775973812, 5866568.344350719824433 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E141", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 928.10003662109375, "elevtn_dn": 936.79998779296875, "invlev_up": 925.60003662109375, "invlev_dn": 934.29998779296875, "manhole_up": "manhole_902_generated", "manhole_dn": "manhole_903_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392166.184986775973812, 5866568.344350719824433 ], [ 1392119.234377897810191, 5866551.59017149079591 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E142", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 936.79998779296875, "elevtn_dn": 936.79998779296875, "invlev_up": 934.29998779296875, "invlev_dn": 934.29998779296875, "manhole_up": "manhole_903_generated", "manhole_dn": "manhole_904_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392119.234377897810191, 5866551.59017149079591 ], [ 1392072.481987217208371, 5866534.25803626794368 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E143", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 936.79998779296875, "elevtn_dn": 929.79998779296875, "invlev_up": 934.29998779296875, "invlev_dn": 927.29998779296875, "manhole_up": "manhole_904_generated", "manhole_dn": "manhole_905_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392072.481987217208371, 5866534.25803626794368 ], [ 1392025.729596536839381, 5866516.925901044160128 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E144", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 929.79998779296875, "elevtn_dn": 892.29998779296875, "invlev_up": 927.29998779296875, "invlev_dn": 889.79998779296875, "manhole_up": "manhole_905_generated", "manhole_dn": "manhole_906_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1392025.729596536839381, 5866516.925901044160128 ], [ 1391978.977205856470391, 5866499.593765820376575 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E145", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 892.29998779296875, "elevtn_dn": 911.4000244140625, "invlev_up": 889.79998779296875, "invlev_dn": 908.9000244140625, "manhole_up": "manhole_906_generated", "manhole_dn": "manhole_907_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391978.977205856470391, 5866499.593765820376575 ], [ 1391932.224815175868571, 5866482.261630596593022 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E146", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 911.4000244140625, "elevtn_dn": 911.4000244140625, "invlev_up": 908.9000244140625, "invlev_dn": 908.9000244140625, "manhole_up": "manhole_907_generated", "manhole_dn": "manhole_908_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391932.224815175868571, 5866482.261630596593022 ], [ 1391885.472424495499581, 5866464.92949537280947 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E147", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 911.4000244140625, "elevtn_dn": 933.20001220703125, "invlev_up": 908.9000244140625, "invlev_dn": 930.70001220703125, "manhole_up": "manhole_908_generated", "manhole_dn": "manhole_909_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391885.472424495499581, 5866464.92949537280947 ], [ 1391838.720033814897761, 5866447.59736014995724 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E148", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 933.20001220703125, "elevtn_dn": 933.20001220703125, "invlev_up": 930.70001220703125, "invlev_dn": 930.70001220703125, "manhole_up": "manhole_909_generated", "manhole_dn": "manhole_910_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391838.720033814897761, 5866447.59736014995724 ], [ 1391791.967643134528771, 5866430.265224926173687 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E149", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 933.20001220703125, "elevtn_dn": 939.4000244140625, "invlev_up": 930.70001220703125, "invlev_dn": 936.9000244140625, "manhole_up": "manhole_910_generated", "manhole_dn": "manhole_911_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391791.967643134528771, 5866430.265224926173687 ], [ 1391745.215252453926951, 5866412.933089702390134 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E150", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 939.4000244140625, "elevtn_dn": 939.4000244140625, "invlev_up": 936.9000244140625, "invlev_dn": 936.9000244140625, "manhole_up": "manhole_911_generated", "manhole_dn": "manhole_912_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391745.215252453926951, 5866412.933089702390134 ], [ 1391698.462861773557961, 5866395.600954478606582 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E151", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 939.4000244140625, "elevtn_dn": 952.70001220703125, "invlev_up": 936.9000244140625, "invlev_dn": 950.20001220703125, "manhole_up": "manhole_912_generated", "manhole_dn": "manhole_913_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391698.462861773557961, 5866395.600954478606582 ], [ 1391651.710471092956141, 5866378.268819254823029 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E152", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 952.70001220703125, "elevtn_dn": 889.4000244140625, "invlev_up": 950.20001220703125, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_913_generated", "manhole_dn": "manhole_914_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391651.710471092956141, 5866378.268819254823029 ], [ 1391604.958080412587151, 5866360.936684031039476 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E153", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 848.70001220703125, "invlev_up": 886.9000244140625, "invlev_dn": 846.20001220703125, "manhole_up": "manhole_914_generated", "manhole_dn": "manhole_915_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391604.958080412587151, 5866360.936684031039476 ], [ 1391558.205689732218161, 5866343.604548808187246 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E154", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 848.70001220703125, "elevtn_dn": 848.70001220703125, "invlev_up": 846.20001220703125, "invlev_dn": 846.20001220703125, "manhole_up": "manhole_915_generated", "manhole_dn": "manhole_916_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391558.205689732218161, 5866343.604548808187246 ], [ 1391511.453299051616341, 5866326.272413584403694 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E155", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 848.70001220703125, "elevtn_dn": 846.0, "invlev_up": 846.20001220703125, "invlev_dn": 843.5, "manhole_up": "manhole_916_generated", "manhole_dn": "manhole_917_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391511.453299051616341, 5866326.272413584403694 ], [ 1391464.700908371247351, 5866308.940278360620141 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E156", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 846.0, "elevtn_dn": 846.0, "invlev_up": 843.5, "invlev_dn": 843.5, "manhole_up": "manhole_917_generated", "manhole_dn": "manhole_918_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391464.700908371247351, 5866308.940278360620141 ], [ 1391417.948517690645531, 5866291.608143136836588 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E157", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 846.0, "elevtn_dn": 849.9000244140625, "invlev_up": 843.5, "invlev_dn": 847.4000244140625, "manhole_up": "manhole_918_generated", "manhole_dn": "manhole_919_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391417.948517690645531, 5866291.608143136836588 ], [ 1391371.196127010276541, 5866274.276007913053036 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E158", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 849.9000244140625, "elevtn_dn": 849.9000244140625, "invlev_up": 847.4000244140625, "invlev_dn": 847.4000244140625, "manhole_up": "manhole_919_generated", "manhole_dn": "manhole_920_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391371.196127010276541, 5866274.276007913053036 ], [ 1391321.986832652939484, 5866269.550851707346737 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E159", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 849.9000244140625, "elevtn_dn": 895.70001220703125, "invlev_up": 847.4000244140625, "invlev_dn": 893.20001220703125, "manhole_up": "manhole_920_generated", "manhole_dn": "manhole_921_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391321.986832652939484, 5866269.550851707346737 ], [ 1391272.147464629728347, 5866268.058758955448866 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E160", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 895.70001220703125, "elevtn_dn": 895.70001220703125, "invlev_up": 893.20001220703125, "invlev_dn": 893.20001220703125, "manhole_up": "manhole_921_generated", "manhole_dn": "manhole_922_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391272.147464629728347, 5866268.058758955448866 ], [ 1391222.30809660628438, 5866266.566666204482317 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E161", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 895.70001220703125, "elevtn_dn": 932.0, "invlev_up": 893.20001220703125, "invlev_dn": 929.5, "manhole_up": "manhole_922_generated", "manhole_dn": "manhole_923_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391222.30809660628438, 5866266.566666204482317 ], [ 1391172.468728582840413, 5866265.074573452584445 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E162", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 932.0, "invlev_up": 929.5, "invlev_dn": 929.5, "manhole_up": "manhole_923_generated", "manhole_dn": "manhole_924_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391172.468728582840413, 5866265.074573452584445 ], [ 1391122.629360559629276, 5866263.582480700686574 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E163", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 932.0, "elevtn_dn": 915.20001220703125, "invlev_up": 929.5, "invlev_dn": 912.70001220703125, "manhole_up": "manhole_924_generated", "manhole_dn": "manhole_925_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391122.629360559629276, 5866263.582480700686574 ], [ 1391072.789992536185309, 5866262.090387949720025 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E164", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 915.20001220703125, "elevtn_dn": 880.70001220703125, "invlev_up": 912.70001220703125, "invlev_dn": 878.20001220703125, "manhole_up": "manhole_925_generated", "manhole_dn": "manhole_926_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391072.789992536185309, 5866262.090387949720025 ], [ 1391022.950624512741342, 5866260.598295197822154 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E165", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 880.70001220703125, "elevtn_dn": 880.70001220703125, "invlev_up": 878.20001220703125, "invlev_dn": 878.20001220703125, "manhole_up": "manhole_926_generated", "manhole_dn": "manhole_927_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1391022.950624512741342, 5866260.598295197822154 ], [ 1390973.111256489530206, 5866259.106202445924282 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E166", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 880.70001220703125, "elevtn_dn": 889.4000244140625, "invlev_up": 878.20001220703125, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_927_generated", "manhole_dn": "manhole_928_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390973.111256489530206, 5866259.106202445924282 ], [ 1390923.271888466086239, 5866257.614109694957733 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E167", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 889.4000244140625, "invlev_up": 886.9000244140625, "invlev_dn": 886.9000244140625, "manhole_up": "manhole_928_generated", "manhole_dn": "manhole_929_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390923.271888466086239, 5866257.614109694957733 ], [ 1390873.432520442642272, 5866256.122016943059862 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E168", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 889.4000244140625, "elevtn_dn": 935.79998779296875, "invlev_up": 886.9000244140625, "invlev_dn": 933.29998779296875, "manhole_up": "manhole_929_generated", "manhole_dn": "manhole_930_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390873.432520442642272, 5866256.122016943059862 ], [ 1390823.593152419198304, 5866254.62992419116199 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E169", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.79998779296875, "elevtn_dn": 935.79998779296875, "invlev_up": 933.29998779296875, "invlev_dn": 933.29998779296875, "manhole_up": "manhole_930_generated", "manhole_dn": "manhole_931_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390823.593152419198304, 5866254.62992419116199 ], [ 1390773.753784395987168, 5866253.137831440195441 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E170", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.79998779296875, "elevtn_dn": 957.79998779296875, "invlev_up": 933.29998779296875, "invlev_dn": 955.29998779296875, "manhole_up": "manhole_931_generated", "manhole_dn": "manhole_932_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390773.753784395987168, 5866253.137831440195441 ], [ 1390723.914416372543201, 5866251.64573868829757 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E171", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.79998779296875, "elevtn_dn": 957.79998779296875, "invlev_up": 955.29998779296875, "invlev_dn": 955.29998779296875, "manhole_up": "manhole_932_generated", "manhole_dn": "manhole_933_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390723.914416372543201, 5866251.64573868829757 ], [ 1390674.075048349099234, 5866250.153645936399698 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E172", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.79998779296875, "elevtn_dn": 957.0, "invlev_up": 955.29998779296875, "invlev_dn": 954.5, "manhole_up": "manhole_933_generated", "manhole_dn": "manhole_934_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390674.075048349099234, 5866250.153645936399698 ], [ 1390624.235680325888097, 5866248.661553185433149 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E173", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.0, "elevtn_dn": 957.0, "invlev_up": 954.5, "invlev_dn": 954.5, "manhole_up": "manhole_934_generated", "manhole_dn": "manhole_935_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390624.235680325888097, 5866248.661553185433149 ], [ 1390574.39631230244413, 5866247.169460433535278 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E174", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 957.0, "elevtn_dn": 964.5, "invlev_up": 954.5, "invlev_dn": 962.0, "manhole_up": "manhole_935_generated", "manhole_dn": "manhole_936_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390574.39631230244413, 5866247.169460433535278 ], [ 1390524.556944279000163, 5866245.677367681637406 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E175", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 964.5, "invlev_up": 962.0, "invlev_dn": 962.0, "manhole_up": "manhole_936_generated", "manhole_dn": "manhole_937_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390524.556944279000163, 5866245.677367681637406 ], [ 1390474.717576255789027, 5866244.185274930670857 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E176", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.5, "elevtn_dn": 948.5, "invlev_up": 962.0, "invlev_dn": 946.0, "manhole_up": "manhole_937_generated", "manhole_dn": "manhole_938_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390474.717576255789027, 5866244.185274930670857 ], [ 1390424.87820823234506, 5866242.693182178772986 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E177", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 948.5, "elevtn_dn": 970.10003662109375, "invlev_up": 946.0, "invlev_dn": 967.60003662109375, "manhole_up": "manhole_938_generated", "manhole_dn": "manhole_939_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390424.87820823234506, 5866242.693182178772986 ], [ 1390375.038840208901092, 5866241.201089426875114 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E178", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 970.10003662109375, "elevtn_dn": 970.10003662109375, "invlev_up": 967.60003662109375, "invlev_dn": 967.60003662109375, "manhole_up": "manhole_939_generated", "manhole_dn": "manhole_940_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390375.038840208901092, 5866241.201089426875114 ], [ 1390325.199472185689956, 5866239.708996675908566 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E179", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 970.10003662109375, "elevtn_dn": 975.4000244140625, "invlev_up": 967.60003662109375, "invlev_dn": 972.9000244140625, "manhole_up": "manhole_940_generated", "manhole_dn": "manhole_941_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390325.199472185689956, 5866239.708996675908566 ], [ 1390275.360104162245989, 5866238.216903924010694 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E180", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 975.4000244140625, "elevtn_dn": 975.4000244140625, "invlev_up": 972.9000244140625, "invlev_dn": 972.9000244140625, "manhole_up": "manhole_941_generated", "manhole_dn": "manhole_942_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390275.360104162245989, 5866238.216903924010694 ], [ 1390225.520736138802022, 5866236.724811173044145 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E181", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 975.4000244140625, "elevtn_dn": 1034.5, "invlev_up": 972.9000244140625, "invlev_dn": 1032.0, "manhole_up": "manhole_942_generated", "manhole_dn": "manhole_943_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390225.520736138802022, 5866236.724811173044145 ], [ 1390175.681368115358055, 5866235.232718421146274 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E182", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1034.5, "elevtn_dn": 1034.5, "invlev_up": 1032.0, "invlev_dn": 1032.0, "manhole_up": "manhole_943_generated", "manhole_dn": "manhole_944_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390175.681368115358055, 5866235.232718421146274 ], [ 1390125.842000092146918, 5866233.740625669248402 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E183", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1034.5, "elevtn_dn": 1053.9000244140625, "invlev_up": 1032.0, "invlev_dn": 1051.4000244140625, "manhole_up": "manhole_944_generated", "manhole_dn": "manhole_945_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390125.842000092146918, 5866233.740625669248402 ], [ 1390076.002632068702951, 5866232.248532918281853 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E184", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1053.9000244140625, "elevtn_dn": 956.9000244140625, "invlev_up": 1051.4000244140625, "invlev_dn": 954.4000244140625, "manhole_up": "manhole_945_generated", "manhole_dn": "manhole_946_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390076.002632068702951, 5866232.248532918281853 ], [ 1390026.163264045258984, 5866230.756440166383982 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E185", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 956.9000244140625, "elevtn_dn": 988.79998779296875, "invlev_up": 954.4000244140625, "invlev_dn": 986.29998779296875, "manhole_up": "manhole_946_generated", "manhole_dn": "manhole_947_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1390026.163264045258984, 5866230.756440166383982 ], [ 1389976.323896022047848, 5866229.26434741448611 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E186", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 988.79998779296875, "elevtn_dn": 988.79998779296875, "invlev_up": 986.29998779296875, "invlev_dn": 986.29998779296875, "manhole_up": "manhole_947_generated", "manhole_dn": "manhole_948_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389976.323896022047848, 5866229.26434741448611 ], [ 1389926.48452799860388, 5866227.772254663519561 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E187", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 988.79998779296875, "elevtn_dn": 1051.0999755859375, "invlev_up": 986.29998779296875, "invlev_dn": 1048.5999755859375, "manhole_up": "manhole_948_generated", "manhole_dn": "manhole_949_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389926.48452799860388, 5866227.772254663519561 ], [ 1389876.645159975159913, 5866226.28016191162169 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E188", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1051.0999755859375, "elevtn_dn": 1051.0999755859375, "invlev_up": 1048.5999755859375, "invlev_dn": 1048.5999755859375, "manhole_up": "manhole_949_generated", "manhole_dn": "manhole_950_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389876.645159975159913, 5866226.28016191162169 ], [ 1389826.805791951948777, 5866224.788069159723818 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E189", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1051.0999755859375, "elevtn_dn": 1066.9000244140625, "invlev_up": 1048.5999755859375, "invlev_dn": 1064.4000244140625, "manhole_up": "manhole_950_generated", "manhole_dn": "manhole_951_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389826.805791951948777, 5866224.788069159723818 ], [ 1389776.96642392850481, 5866223.295976408757269 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E190", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1066.9000244140625, "elevtn_dn": 1031.2000732421875, "invlev_up": 1064.4000244140625, "invlev_dn": 1028.7000732421875, "manhole_up": "manhole_951_generated", "manhole_dn": "manhole_952_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389776.96642392850481, 5866223.295976408757269 ], [ 1389727.141182830790058, 5866221.468200048431754 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E191", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1031.2000732421875, "elevtn_dn": 1031.2000732421875, "invlev_up": 1028.7000732421875, "invlev_dn": 1028.7000732421875, "manhole_up": "manhole_952_generated", "manhole_dn": "manhole_953_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389727.141182830790058, 5866221.468200048431754 ], [ 1389677.352675863076001, 5866218.767548334784806 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E192", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1031.2000732421875, "elevtn_dn": 986.60003662109375, "invlev_up": 1028.7000732421875, "invlev_dn": 984.10003662109375, "manhole_up": "manhole_953_generated", "manhole_dn": "manhole_954_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389677.352675863076001, 5866218.767548334784806 ], [ 1389627.564168895594776, 5866216.066896621137857 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E193", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 986.60003662109375, "elevtn_dn": 986.60003662109375, "invlev_up": 984.10003662109375, "invlev_dn": 984.10003662109375, "manhole_up": "manhole_954_generated", "manhole_dn": "manhole_955_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389627.564168895594776, 5866216.066896621137857 ], [ 1389577.775661927880719, 5866213.366244907490909 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E194", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 986.60003662109375, "elevtn_dn": 964.70001220703125, "invlev_up": 984.10003662109375, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_955_generated", "manhole_dn": "manhole_956_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389577.775661927880719, 5866213.366244907490909 ], [ 1389527.987154960166663, 5866210.665593194775283 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E195", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 964.70001220703125, "invlev_up": 962.20001220703125, "invlev_dn": 962.20001220703125, "manhole_up": "manhole_956_generated", "manhole_dn": "manhole_957_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389527.987154960166663, 5866210.665593194775283 ], [ 1389478.198647992452607, 5866207.964941481128335 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E196", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 964.70001220703125, "elevtn_dn": 996.29998779296875, "invlev_up": 962.20001220703125, "invlev_dn": 993.79998779296875, "manhole_up": "manhole_957_generated", "manhole_dn": "manhole_958_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389478.198647992452607, 5866207.964941481128335 ], [ 1389428.41014102473855, 5866205.264289767481387 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E197", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 996.29998779296875, "elevtn_dn": 996.29998779296875, "invlev_up": 993.79998779296875, "invlev_dn": 993.79998779296875, "manhole_up": "manhole_958_generated", "manhole_dn": "manhole_959_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389428.41014102473855, 5866205.264289767481387 ], [ 1389378.621634057024494, 5866202.563638053834438 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E198", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 996.29998779296875, "elevtn_dn": 1030.4000244140625, "invlev_up": 993.79998779296875, "invlev_dn": 1027.9000244140625, "manhole_up": "manhole_959_generated", "manhole_dn": "manhole_960_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389378.621634057024494, 5866202.563638053834438 ], [ 1389328.833127089310437, 5866199.86298634018749 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E199", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1030.4000244140625, "elevtn_dn": 1030.4000244140625, "invlev_up": 1027.9000244140625, "invlev_dn": 1027.9000244140625, "manhole_up": "manhole_960_generated", "manhole_dn": "manhole_961_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389328.833127089310437, 5866199.86298634018749 ], [ 1389279.044620121829212, 5866197.162334626540542 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E200", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1030.4000244140625, "elevtn_dn": 1053.800048828125, "invlev_up": 1027.9000244140625, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_961_generated", "manhole_dn": "manhole_962_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389279.044620121829212, 5866197.162334626540542 ], [ 1389229.256113154115155, 5866194.461682912893593 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E201", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1053.800048828125, "invlev_up": 1051.300048828125, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_962_generated", "manhole_dn": "manhole_963_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389229.256113154115155, 5866194.461682912893593 ], [ 1389179.467606186401099, 5866191.761031199246645 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E202", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1067.5999755859375, "invlev_up": 1051.300048828125, "invlev_dn": 1065.0999755859375, "manhole_up": "manhole_963_generated", "manhole_dn": "manhole_964_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389179.467606186401099, 5866191.761031199246645 ], [ 1389129.679099218687043, 5866189.060379485599697 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E203", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1067.5999755859375, "elevtn_dn": 1070.7000732421875, "invlev_up": 1065.0999755859375, "invlev_dn": 1068.2000732421875, "manhole_up": "manhole_964_generated", "manhole_dn": "manhole_965_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389129.679099218687043, 5866189.060379485599697 ], [ 1389079.890592250972986, 5866186.359727771952748 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E204", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1070.7000732421875, "elevtn_dn": 1070.7000732421875, "invlev_up": 1068.2000732421875, "invlev_dn": 1068.2000732421875, "manhole_up": "manhole_965_generated", "manhole_dn": "manhole_966_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389079.890592250972986, 5866186.359727771952748 ], [ 1389030.10208528325893, 5866183.6590760583058 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E205", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1070.7000732421875, "elevtn_dn": 1075.0, "invlev_up": 1068.2000732421875, "invlev_dn": 1072.5, "manhole_up": "manhole_966_generated", "manhole_dn": "manhole_967_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1389030.10208528325893, 5866183.6590760583058 ], [ 1388980.313578315777704, 5866180.958424345590174 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E206", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1075.0, "elevtn_dn": 1075.0, "invlev_up": 1072.5, "invlev_dn": 1072.5, "manhole_up": "manhole_967_generated", "manhole_dn": "manhole_968_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388980.313578315777704, 5866180.958424345590174 ], [ 1388930.525071348063648, 5866178.257772631943226 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E207", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1075.0, "elevtn_dn": 1074.0999755859375, "invlev_up": 1072.5, "invlev_dn": 1071.5999755859375, "manhole_up": "manhole_968_generated", "manhole_dn": "manhole_969_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388930.525071348063648, 5866178.257772631943226 ], [ 1388880.736564380349591, 5866175.557120918296278 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E208", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1074.0999755859375, "elevtn_dn": 1074.0999755859375, "invlev_up": 1071.5999755859375, "invlev_dn": 1071.5999755859375, "manhole_up": "manhole_969_generated", "manhole_dn": "manhole_970_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388880.736564380349591, 5866175.557120918296278 ], [ 1388830.948057412635535, 5866172.856469204649329 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E209", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1074.0999755859375, "elevtn_dn": 1053.800048828125, "invlev_up": 1071.5999755859375, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_970_generated", "manhole_dn": "manhole_971_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388830.948057412635535, 5866172.856469204649329 ], [ 1388781.159550444921479, 5866170.155817491002381 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E210", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1053.800048828125, "invlev_up": 1051.300048828125, "invlev_dn": 1051.300048828125, "manhole_up": "manhole_971_generated", "manhole_dn": "manhole_972_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388781.159550444921479, 5866170.155817491002381 ], [ 1388731.371043477207422, 5866167.455165777355433 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E211", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1053.800048828125, "elevtn_dn": 1017.0, "invlev_up": 1051.300048828125, "invlev_dn": 1014.5, "manhole_up": "manhole_972_generated", "manhole_dn": "manhole_973_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388731.371043477207422, 5866167.455165777355433 ], [ 1388681.582536509493366, 5866164.754514063708484 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E212", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1017.0, "elevtn_dn": 1017.0, "invlev_up": 1014.5, "invlev_dn": 1014.5, "manhole_up": "manhole_973_generated", "manhole_dn": "manhole_974_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388681.582536509493366, 5866164.754514063708484 ], [ 1388631.79402954201214, 5866162.053862350061536 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E213", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 1017.0, "elevtn_dn": 973.20001220703125, "invlev_up": 1014.5, "invlev_dn": 970.70001220703125, "manhole_up": "manhole_974_generated", "manhole_dn": "manhole_975_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388631.79402954201214, 5866162.053862350061536 ], [ 1388582.005522574298084, 5866159.353210636414587 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E214", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 973.20001220703125, "elevtn_dn": 973.20001220703125, "invlev_up": 970.70001220703125, "invlev_dn": 970.70001220703125, "manhole_up": "manhole_975_generated", "manhole_dn": "manhole_976_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388582.005522574298084, 5866159.353210636414587 ], [ 1388532.217015606584027, 5866156.652558922767639 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E215", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 973.20001220703125, "elevtn_dn": 935.20001220703125, "invlev_up": 970.70001220703125, "invlev_dn": 932.70001220703125, "manhole_up": "manhole_976_generated", "manhole_dn": "manhole_977_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388532.217015606584027, 5866156.652558922767639 ], [ 1388482.428508638869971, 5866153.951907209120691 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E216", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.20001220703125, "elevtn_dn": 935.20001220703125, "invlev_up": 932.70001220703125, "invlev_dn": 932.70001220703125, "manhole_up": "manhole_977_generated", "manhole_dn": "manhole_978_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388482.428508638869971, 5866153.951907209120691 ], [ 1388432.640001671155915, 5866151.251255496405065 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E217", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 935.20001220703125, "elevtn_dn": 895.79998779296875, "invlev_up": 932.70001220703125, "invlev_dn": 893.29998779296875, "manhole_up": "manhole_978_generated", "manhole_dn": "manhole_979_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388432.640001671155915, 5866151.251255496405065 ], [ 1388382.851494703441858, 5866148.550603782758117 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E218", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 895.79998779296875, "elevtn_dn": 852.60003662109375, "invlev_up": 893.29998779296875, "invlev_dn": 850.10003662109375, "manhole_up": "manhole_979_generated", "manhole_dn": "manhole_980_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388382.851494703441858, 5866148.550603782758117 ], [ 1388333.062987735960633, 5866145.849952069111168 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E219", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 852.60003662109375, "elevtn_dn": 852.60003662109375, "invlev_up": 850.10003662109375, "invlev_dn": 850.10003662109375, "manhole_up": "manhole_980_generated", "manhole_dn": "manhole_981_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388333.062987735960633, 5866145.849952069111168 ], [ 1388283.274480768246576, 5866143.14930035546422 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E220", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 852.60003662109375, "elevtn_dn": 818.4000244140625, "invlev_up": 850.10003662109375, "invlev_dn": 815.9000244140625, "manhole_up": "manhole_981_generated", "manhole_dn": "manhole_982_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388283.274480768246576, 5866143.14930035546422 ], [ 1388233.48597380053252, 5866140.448648641817272 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_49_E221", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_49", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_49", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 818.4000244140625, "elevtn_dn": 818.4000244140625, "invlev_up": 815.9000244140625, "invlev_dn": 815.9000244140625, "manhole_up": "manhole_982_generated", "manhole_dn": "manhole_983_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388233.48597380053252, 5866140.448648641817272 ], [ 1388183.697466832818463, 5866137.747996928170323 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_50_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 792.20001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_851_generated", "manhole_dn": "manhole_984_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387913.197226775344461, 5865736.839239663444459 ], [ 1387925.20445894007571, 5865784.545682998374104 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_50_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 804.4000244140625, "invlev_up": 792.20001220703125, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_984_generated", "manhole_dn": "manhole_985_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387925.20445894007571, 5865784.545682998374104 ], [ 1387937.21169110503979, 5865832.252126332372427 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_50_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_985_generated", "manhole_dn": "manhole_986_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387937.21169110503979, 5865832.252126332372427 ], [ 1387954.8270876808092, 5865878.043407939374447 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_50_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_986_generated", "manhole_dn": "manhole_987_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387954.8270876808092, 5865878.043407939374447 ], [ 1387967.620662312954664, 5865925.436966767534614 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_50_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 778.20001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_987_generated", "manhole_dn": "manhole_988_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387967.620662312954664, 5865925.436966767534614 ], [ 1387969.561903131194413, 5865974.386314341798425 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_50_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_988_generated", "manhole_dn": "manhole_989_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.561903131194413, 5865974.386314341798425 ], [ 1387968.98255812516436, 5866023.571071763522923 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_50_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 778.20001220703125, "invlev_up": 775.70001220703125, "invlev_dn": 775.70001220703125, "manhole_up": "manhole_989_generated", "manhole_dn": "manhole_990_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387968.98255812516436, 5866023.571071763522923 ], [ 1387969.225197304505855, 5866072.657253311946988 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_50_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 778.20001220703125, "elevtn_dn": 786.29998779296875, "invlev_up": 775.70001220703125, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_990_generated", "manhole_dn": "manhole_991_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387969.225197304505855, 5866072.657253311946988 ], [ 1387988.247399942483753, 5866112.298415473662317 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_50_E8", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_50", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_50", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 786.29998779296875, "invlev_up": 783.79998779296875, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_991_generated", "manhole_dn": "manhole_992_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387988.247399942483753, 5866112.298415473662317 ], [ 1388034.037428337847814, 5866130.255607943050563 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_51_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 786.29998779296875, "invlev_up": 783.79998779296875, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_992_generated", "manhole_dn": "manhole_993_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388034.037428337847814, 5866130.255607943050563 ], [ 1387988.210684564430267, 5866144.678138472139835 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_51_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 786.29998779296875, "elevtn_dn": 803.9000244140625, "invlev_up": 783.79998779296875, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_993_generated", "manhole_dn": "manhole_994_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387988.210684564430267, 5866144.678138472139835 ], [ 1387944.406121137319133, 5866164.065103021450341 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_51_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_994_generated", "manhole_dn": "manhole_995_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387944.406121137319133, 5866164.065103021450341 ], [ 1387898.376188111724332, 5866173.560075835324824 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_51_E3", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 827.70001220703125, "invlev_up": 801.4000244140625, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_995_generated", "manhole_dn": "manhole_996_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387898.376188111724332, 5866173.560075835324824 ], [ 1387861.922560503939167, 5866145.113870099186897 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_51_E4", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 827.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 825.20001220703125, "manhole_up": "manhole_996_generated", "manhole_dn": "manhole_997_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387861.922560503939167, 5866145.113870099186897 ], [ 1387862.597008766839281, 5866099.287653629668057 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_51_E5", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 827.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 825.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_997_generated", "manhole_dn": "manhole_998_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387862.597008766839281, 5866099.287653629668057 ], [ 1387894.296242429409176, 5866064.31225199252367 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_51_E6", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_998_generated", "manhole_dn": "manhole_999_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387894.296242429409176, 5866064.31225199252367 ], [ 1387918.333023339277133, 5866023.860149594023824 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_51_E7", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 816.70001220703125, "invlev_up": 814.20001220703125, "invlev_dn": 814.20001220703125, "manhole_up": "manhole_999_generated", "manhole_dn": "manhole_1000_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387918.333023339277133, 5866023.860149594023824 ], [ 1387925.576027213362977, 5865976.462517648003995 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_51_E8", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 816.70001220703125, "elevtn_dn": 804.4000244140625, "invlev_up": 814.20001220703125, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1000_generated", "manhole_dn": "manhole_1001_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387925.576027213362977, 5865976.462517648003995 ], [ 1387926.166851800866425, 5865928.505292822606862 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_51_E9", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1001_generated", "manhole_dn": "manhole_1002_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387926.166851800866425, 5865928.505292822606862 ], [ 1387922.175474973395467, 5865880.628693707287312 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_51_E10", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 804.4000244140625, "invlev_up": 801.9000244140625, "invlev_dn": 801.9000244140625, "manhole_up": "manhole_1002_generated", "manhole_dn": "manhole_1003_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387922.175474973395467, 5865880.628693707287312 ], [ 1387918.184098146157339, 5865832.752094592899084 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_51_E11", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 804.4000244140625, "elevtn_dn": 794.70001220703125, "invlev_up": 801.9000244140625, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_1003_generated", "manhole_dn": "manhole_1004_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387918.184098146157339, 5865832.752094592899084 ], [ 1387914.316889721900225, 5865784.868878290057182 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_51_E12", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_51", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_51", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 794.70001220703125, "elevtn_dn": 794.70001220703125, "invlev_up": 792.20001220703125, "invlev_dn": 792.20001220703125, "manhole_up": "manhole_1004_generated", "manhole_dn": "manhole_851_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1387914.316889721900225, 5865784.868878290057182 ], [ 1387913.197226775344461, 5865736.839239663444459 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_52_E0", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_52", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 818.4000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 815.9000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_983_generated", "manhole_dn": "manhole_1005_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388183.697466832818463, 5866137.747996928170323 ], [ 1388133.810787334572524, 5866135.250533932819963 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_52_E1", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_52", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 803.9000244140625, "invlev_up": 801.4000244140625, "invlev_dn": 801.4000244140625, "manhole_up": "manhole_1005_generated", "manhole_dn": "manhole_1006_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388133.810787334572524, 5866135.250533932819963 ], [ 1388083.924107836093754, 5866132.753070938400924 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "pipe", "bedlev": null, "branchid": "pipe_52_E2", "width": null, "height": null, "branchorder": "-1", "friction_type": null, "friction_value": null, "shape": "circle", "t_width": null, "closed": "yes", "ORIG_branchid": "pipe_52", "frictiontype": "WhiteColeBrook", "frictionvalue": 0.003, "frictionid": "WhiteColeBrook_0.003", "index": "pipe_52", "diameter": 0.5, "index_right": 0.0, "elevtn_up": 803.9000244140625, "elevtn_dn": 786.29998779296875, "invlev_up": 801.4000244140625, "invlev_dn": 783.79998779296875, "manhole_up": "manhole_1006_generated", "manhole_dn": "manhole_992_generated" }, "geometry": { "type": "LineString", "coordinates": [ [ 1388083.924107836093754, 5866132.753070938400924 ], [ 1388034.037428337847814, 5866130.255607943050563 ] ] } } ] } diff --git a/examples/dflowfm_piave/geoms/rivers.geojson b/examples/dflowfm_piave/geoms/rivers.geojson index fcf98866..065711ab 100644 --- a/examples/dflowfm_piave/geoms/rivers.geojson +++ b/examples/dflowfm_piave/geoms/rivers.geojson @@ -2,20 +2,11 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::3857" } }, "features": [ -<<<<<<< HEAD -{ "type": "Feature", "properties": { "height": 22.5, "bedlev": 865.60003662109375, "width": 60.500781333333329, "branchid": "river_1", "branchtype": "river", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_1", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1394694.070276216836646, 5867648.108302162960172 ], [ 1394694.070276216836646, 5867513.239712204784155 ], [ 1394601.304033889202401, 5867378.373192292638123 ], [ 1394508.537791561568156, 5867243.508742331527174 ], [ 1394415.771549233933911, 5867243.508742331527174 ], [ 1394323.005306906066835, 5867108.646362232975662 ], [ 1394230.23906457843259, 5867108.646362232975662 ], [ 1394137.472822251031175, 5867108.646362232975662 ], [ 1394044.70657992339693, 5866973.78605190385133 ], [ 1393951.940337595762685, 5866973.78605190385133 ], [ 1393859.17409526812844, 5866973.78605190385133 ], [ 1393766.407852940494195, 5866838.927811251021922 ], [ 1393673.641610612627119, 5866838.927811251021922 ], [ 1393580.875368284992874, 5866838.927811251021922 ], [ 1393488.109125957358629, 5866838.927811251021922 ], [ 1393395.342883629724383, 5866838.927811251021922 ], [ 1393302.576641302322969, 5866838.927811251021922 ], [ 1393209.810398974688724, 5866838.927811251021922 ], [ 1393117.044156646821648, 5866704.071640183217824 ], [ 1393024.277914319187403, 5866704.071640183217824 ], [ 1392931.511671991553158, 5866704.071640183217824 ], [ 1392838.745429663918912, 5866704.071640183217824 ], [ 1392745.979187336284667, 5866569.217538607306778 ], [ 1392653.212945008650422, 5866569.217538607306778 ], [ 1392560.446702681016177, 5866569.217538607306778 ], [ 1392467.680460353381932, 5866569.217538607306778 ], [ 1392374.914218025747687, 5866569.217538607306778 ], [ 1392282.147975698113441, 5866434.365506432950497 ], [ 1392189.381733370479196, 5866299.515543567948043 ], [ 1392096.615491042844951, 5866299.515543567948043 ], [ 1392003.849248715210706, 5866299.515543567948043 ], [ 1391911.083006387576461, 5866299.515543567948043 ], [ 1391818.316764059709385, 5866164.667649918235838 ], [ 1391725.55052173207514, 5866164.667649918235838 ], [ 1391632.784279404673725, 5866164.667649918235838 ], [ 1391540.01803707703948, 5866164.667649918235838 ], [ 1391447.251794749405235, 5866164.667649918235838 ], [ 1391354.48555242177099, 5866164.667649918235838 ], [ 1391261.719310093903914, 5866164.667649918235838 ], [ 1391168.953067766269669, 5866164.667649918235838 ], [ 1391076.186825438635424, 5866164.667649918235838 ], [ 1390983.420583111001179, 5866164.667649918235838 ], [ 1390890.654340783366933, 5866164.667649918235838 ], [ 1390797.888098455965519, 5866029.821825394406915 ], [ 1390705.121856128098443, 5866029.821825394406915 ], [ 1390612.355613800464198, 5866029.821825394406915 ], [ 1390519.589371472829953, 5866029.821825394406915 ], [ 1390426.823129145195708, 5866029.821825394406915 ], [ 1390334.056886817561463, 5866029.821825394406915 ], [ 1390241.290644489927217, 5866029.821825394406915 ], [ 1390148.524402162292972, 5865894.978069902397692 ], [ 1390055.758159834658727, 5865894.978069902397692 ], [ 1389962.991917507024482, 5865760.136383352801204 ], [ 1389870.225675179390237, 5865760.136383352801204 ], [ 1389777.459432851755992, 5865760.136383352801204 ], [ 1389684.693190524121746, 5865760.136383352801204 ], [ 1389591.926948196487501, 5865760.136383352801204 ], [ 1389499.160705868853256, 5865625.296765649691224 ], [ 1389406.39446354098618, 5865625.296765649691224 ], [ 1389406.39446354098618, 5865490.459216705523431 ], [ 1389313.628221213351935, 5865355.623736422508955 ], [ 1389313.628221213351935, 5865220.790324714966118 ], [ 1389313.628221213351935, 5865085.958981488831341 ], [ 1389220.86197888571769, 5864951.129706650041044 ], [ 1389128.095736558316275, 5864816.302500107325613 ], [ 1389128.095736558316275, 5864681.477361769415438 ], [ 1389035.32949423068203, 5864546.654291545972228 ], [ 1389128.095736558316275, 5864411.833289342001081 ], [ 1389128.095736558316275, 5864277.014355068095028 ], [ 1389035.32949423068203, 5864142.197488628327847 ], [ 1388942.563251903047785, 5864007.382689936086535 ], [ 1388849.797009575180709, 5863872.569958896376193 ], [ 1388757.030767247546464, 5863872.569958896376193 ], [ 1388664.264524919912219, 5863737.759295416995883 ], [ 1388571.498282592277974, 5863602.950699406675994 ], [ 1388571.498282592277974, 5863468.144170773215592 ], [ 1388571.498282592277974, 5863333.339709427207708 ], [ 1388478.732040264643729, 5863333.339709427207708 ], [ 1388385.965797937009484, 5863198.537315272726119 ], [ 1388293.199555609375238, 5863198.537315272726119 ], [ 1388200.433313281740993, 5863198.537315272726119 ], [ 1388107.667070954106748, 5863063.736988220363855 ], [ 1388014.900828626472503, 5863063.736988220363855 ], [ 1387922.134586298838258, 5863063.736988220363855 ], [ 1387829.368343971204013, 5862928.938728176057339 ], [ 1387736.602101643569767, 5862794.142535050399601 ], [ 1387736.602101643569767, 5862659.348408752121031 ], [ 1387736.602101643569767, 5862524.556349185295403 ], [ 1387643.835859315935522, 5862389.766356259584427 ], [ 1387551.069616988068447, 5862254.978429886512458 ], [ 1387458.303374660667032, 5862254.978429886512458 ], [ 1387365.537132333032787, 5862254.978429886512458 ], [ 1387272.770890005398542, 5862254.978429886512458 ], [ 1387180.004647677764297, 5862254.978429886512458 ], [ 1387087.238405350130051, 5862254.978429886512458 ], [ 1386994.472163022495806, 5862120.192569970153272 ] ] } }, -{ "type": "Feature", "properties": { "height": 13.574996948242188, "bedlev": 813.29998779296875, "width": 63.595319, "branchid": "river_2", "branchtype": "river", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_2", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386066.809739745920524, 5868052.726493230089545 ], [ 1386159.575982073554769, 5868052.726493230089545 ], [ 1386252.342224401189014, 5867917.851692584343255 ], [ 1386345.108466728823259, 5867917.851692584343255 ], [ 1386437.874709056690335, 5867917.851692584343255 ], [ 1386530.64095138432458, 5867917.851692584343255 ], [ 1386623.407193711958826, 5867917.851692584343255 ], [ 1386716.17343603936024, 5867782.978962258435786 ], [ 1386808.939678366994485, 5867782.978962258435786 ], [ 1386901.70592069462873, 5867782.978962258435786 ], [ 1386994.472163022495806, 5867648.108302162960172 ], [ 1387087.238405350130051, 5867648.108302162960172 ], [ 1387180.004647677764297, 5867513.239712204784155 ], [ 1387272.770890005398542, 5867378.373192292638123 ], [ 1387365.537132333032787, 5867243.508742331527174 ], [ 1387458.303374660667032, 5867108.646362232975662 ], [ 1387551.069616988068447, 5867108.646362232975662 ], [ 1387643.835859315935522, 5867108.646362232975662 ], [ 1387736.602101643569767, 5866973.78605190385133 ], [ 1387829.368343971204013, 5866973.78605190385133 ], [ 1387829.368343971204013, 5866838.927811251021922 ], [ 1387829.368343971204013, 5866704.071640183217824 ], [ 1387829.368343971204013, 5866569.217538607306778 ], [ 1387922.134586298838258, 5866434.365506432950497 ], [ 1387922.134586298838258, 5866299.515543567948043 ], [ 1388014.900828626472503, 5866164.667649918235838 ], [ 1388014.900828626472503, 5866029.821825394406915 ], [ 1388014.900828626472503, 5865894.978069902397692 ], [ 1388014.900828626472503, 5865760.136383352801204 ], [ 1387922.134586298838258, 5865625.296765649691224 ], [ 1387922.134586298838258, 5865490.459216705523431 ], [ 1387922.134586298838258, 5865355.623736422508955 ], [ 1387922.134586298838258, 5865220.790324714966118 ], [ 1387922.134586298838258, 5865085.958981488831341 ], [ 1387829.368343971204013, 5864951.129706650041044 ], [ 1387829.368343971204013, 5864816.302500107325613 ], [ 1387829.368343971204013, 5864681.477361769415438 ], [ 1387829.368343971204013, 5864546.654291545972228 ], [ 1387829.368343971204013, 5864411.833289342001081 ], [ 1387829.368343971204013, 5864277.014355068095028 ], [ 1387736.602101643569767, 5864142.197488628327847 ], [ 1387643.835859315935522, 5864007.382689936086535 ], [ 1387551.069616988068447, 5863872.569958896376193 ], [ 1387551.069616988068447, 5863737.759295416995883 ], [ 1387458.303374660667032, 5863602.950699406675994 ], [ 1387365.537132333032787, 5863468.144170773215592 ], [ 1387272.770890005398542, 5863333.339709427207708 ], [ 1387272.770890005398542, 5863198.537315272726119 ], [ 1387180.004647677764297, 5863063.736988220363855 ], [ 1387087.238405350130051, 5862928.938728176057339 ], [ 1386994.472163022495806, 5862794.142535050399601 ], [ 1386901.70592069462873, 5862794.142535050399601 ], [ 1386808.939678366994485, 5862659.348408752121031 ], [ 1386716.17343603936024, 5862524.556349185295403 ], [ 1386716.17343603936024, 5862389.766356259584427 ], [ 1386716.17343603936024, 5862254.978429886512458 ], [ 1386808.939678366994485, 5862254.978429886512458 ], [ 1386901.70592069462873, 5862120.192569970153272 ], [ 1386994.472163022495806, 5862120.192569970153272 ] ] } }, -{ "type": "Feature", "properties": { "height": 21.70001220703125, "bedlev": 952.79998779296875, "width": 50.0, "branchid": "river_3", "branchtype": "river", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_3", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1391540.01803707703948, 5858077.577220032922924 ], [ 1391447.251794749405235, 5858077.577220032922924 ], [ 1391354.48555242177099, 5858077.577220032922924 ], [ 1391261.719310093903914, 5858077.577220032922924 ], [ 1391168.953067766269669, 5858077.577220032922924 ], [ 1391076.186825438635424, 5858212.301128903403878 ], [ 1390983.420583111001179, 5858212.301128903403878 ], [ 1390890.654340783366933, 5858212.301128903403878 ], [ 1390797.888098455965519, 5858077.577220032922924 ], [ 1390705.121856128098443, 5858077.577220032922924 ], [ 1390612.355613800464198, 5858077.577220032922924 ], [ 1390519.589371472829953, 5858077.577220032922924 ], [ 1390426.823129145195708, 5858077.577220032922924 ], [ 1390334.056886817561463, 5857942.855374777689576 ], [ 1390241.290644489927217, 5857942.855374777689576 ], [ 1390148.524402162292972, 5857942.855374777689576 ], [ 1390055.758159834658727, 5857808.135593040846288 ], [ 1389962.991917507024482, 5857808.135593040846288 ], [ 1389962.991917507024482, 5857673.41787473578006 ], [ 1389870.225675179390237, 5857673.41787473578006 ], [ 1389777.459432851755992, 5857673.41787473578006 ], [ 1389684.693190524121746, 5857808.135593040846288 ], [ 1389591.926948196487501, 5857808.135593040846288 ], [ 1389499.160705868853256, 5857808.135593040846288 ], [ 1389406.39446354098618, 5857808.135593040846288 ], [ 1389313.628221213351935, 5857942.855374777689576 ], [ 1389220.86197888571769, 5858077.577220032922924 ], [ 1389128.095736558316275, 5858212.301128903403878 ], [ 1389035.32949423068203, 5858212.301128903403878 ], [ 1388942.563251903047785, 5858347.02710147574544 ], [ 1388849.797009575180709, 5858347.02710147574544 ], [ 1388757.030767247546464, 5858347.02710147574544 ], [ 1388664.264524919912219, 5858481.755137845873833 ], [ 1388571.498282592277974, 5858481.755137845873833 ], [ 1388478.732040264643729, 5858481.755137845873833 ], [ 1388385.965797937009484, 5858481.755137845873833 ], [ 1388293.199555609375238, 5858481.755137845873833 ], [ 1388200.433313281740993, 5858616.485238100402057 ], [ 1388107.667070954106748, 5858751.217402336187661 ], [ 1388014.900828626472503, 5858885.951630645431578 ], [ 1387922.134586298838258, 5858885.951630645431578 ], [ 1387829.368343971204013, 5858885.951630645431578 ], [ 1387736.602101643569767, 5858885.951630645431578 ], [ 1387643.835859315935522, 5858885.951630645431578 ], [ 1387551.069616988068447, 5858885.951630645431578 ], [ 1387458.303374660667032, 5858885.951630645431578 ], [ 1387365.537132333032787, 5858885.951630645431578 ], [ 1387272.770890005398542, 5858885.951630645431578 ], [ 1387180.004647677764297, 5858885.951630645431578 ], [ 1387087.238405350130051, 5858885.951630645431578 ], [ 1386994.472163022495806, 5858885.951630645431578 ], [ 1386901.70592069462873, 5858885.951630645431578 ], [ 1386808.939678366994485, 5858885.951630645431578 ], [ 1386716.17343603936024, 5859020.687923114746809 ], [ 1386623.407193711958826, 5859020.687923114746809 ], [ 1386530.64095138432458, 5859020.687923114746809 ], [ 1386437.874709056690335, 5859020.687923114746809 ], [ 1386345.108466728823259, 5859020.687923114746809 ] ] } }, -{ "type": "Feature", "properties": { "height": 14.050003051757812, "bedlev": 724.29998779296875, "width": 60.93007025, "branchid": "river_4", "branchtype": "river", "branchorder": "1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_4", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386994.472163022495806, 5862120.192569970153272 ], [ 1386901.70592069462873, 5861985.408776421099901 ], [ 1386808.939678366994485, 5861850.627049146220088 ], [ 1386716.17343603936024, 5861715.847388052381575 ], [ 1386716.17343603936024, 5861581.069793051108718 ], [ 1386716.17343603936024, 5861446.294264048337936 ], [ 1386648.271799877518788, 5861347.644815167412162 ] ] } }, -{ "type": "Feature", "properties": { "height": 14.050003051757812, "bedlev": 724.29998779296875, "width": 60.93007025, "branchid": "river_4-1", "branchtype": "river", "branchorder": "1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_4", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386648.271799877518788, 5861347.644815167412162 ], [ 1386623.407193711958826, 5861311.520800951868296 ], [ 1386623.407193711958826, 5861176.749403670430183 ], [ 1386530.64095138432458, 5861176.749403670430183 ], [ 1386437.874709056690335, 5861041.98007211368531 ], [ 1386437.874709056690335, 5860907.212806186638772 ], [ 1386437.874709056690335, 5860772.447605801746249 ], [ 1386437.874709056690335, 5860637.684470863081515 ], [ 1386345.108466728823259, 5860502.92340128030628 ], [ 1386345.108466728823259, 5860368.164396961219609 ], [ 1386252.342224401189014, 5860233.407457816414535 ], [ 1386159.575982073554769, 5860098.652583750896156 ], [ 1386159.575982073554769, 5859963.899774673394859 ], [ 1386159.575982073554769, 5859829.149030494503677 ], [ 1386159.575982073554769, 5859694.40035112015903 ], [ 1386252.342224401189014, 5859559.653736459091306 ], [ 1386252.342224401189014, 5859424.909186420030892 ], [ 1386252.342224401189014, 5859290.166700910776854 ], [ 1386252.342224401189014, 5859155.426279840059578 ], [ 1386345.108466728823259, 5859020.687923114746809 ] ] } }, -{ "type": "Feature", "properties": { "height": 17.349960327148438, "bedlev": 701.4000244140625, "width": 60.93007025, "branchid": "river_5", "branchtype": "river", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": "0.023", "ORIG_branchid": "river_5", "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386345.108466728823259, 5859020.687923114746809 ], [ 1386252.342224401189014, 5858885.951630645431578 ], [ 1386159.575982073554769, 5858751.217402336187661 ], [ 1386159.575982073554769, 5858616.485238100402057 ], [ 1386159.575982073554769, 5858481.755137845873833 ], [ 1386159.575982073554769, 5858347.02710147574544 ], [ 1386066.809739745920524, 5858212.301128903403878 ], [ 1385974.043497418286279, 5858212.301128903403878 ], [ 1385881.277255090652034, 5858212.301128903403878 ], [ 1385788.511012763017789, 5858212.301128903403878 ], [ 1385695.744770435383543, 5858212.301128903403878 ], [ 1385602.978528107749298, 5858077.577220032922924 ], [ 1385510.212285780115053, 5857942.855374777689576 ], [ 1385510.212285780115053, 5857808.135593040846288 ], [ 1385417.446043452480808, 5857673.41787473578006 ], [ 1385324.679801124846563, 5857673.41787473578006 ], [ 1385231.913558797212318, 5857538.702219764702022 ], [ 1385231.913558797212318, 5857403.988628041930497 ], [ 1385231.913558797212318, 5857269.277099471539259 ], [ 1385231.913558797212318, 5857134.567633965052664 ], [ 1385324.679801124846563, 5856999.86023142747581 ], [ 1385231.913558797212318, 5856865.154891769401729 ], [ 1385231.913558797212318, 5856730.451614898629487 ], [ 1385139.147316469578072, 5856595.750400722958148 ], [ 1385046.381074141710997, 5856595.750400722958148 ], [ 1384953.614831814309582, 5856461.051249152049422 ], [ 1384860.848589486675337, 5856461.051249152049422 ], [ 1384768.082347159041092, 5856326.354160091839731 ], [ 1384768.082347159041092, 5856191.659133453853428 ], [ 1384675.316104831406847, 5856056.966169144026935 ], [ 1384582.549862503772601, 5856056.966169144026935 ], [ 1384489.783620175905526, 5855922.275267072021961 ], [ 1384397.017377848271281, 5855787.586427145637572 ], [ 1384304.251135520637035, 5855787.586427145637572 ], [ 1384211.48489319300279, 5855652.899649272672832 ], [ 1384118.718650865368545, 5855518.21493336185813 ], [ 1384025.952408537967131, 5855383.532279322855175 ], [ 1383933.186166210100055, 5855248.851687061600387 ], [ 1383840.41992388246581, 5855248.851687061600387 ], [ 1383747.653681554831564, 5855114.1731564886868 ], [ 1383747.653681554831564, 5854979.496687510982156 ], [ 1383747.653681554831564, 5854844.822280039079487 ], [ 1383654.887439227197319, 5854844.822280039079487 ], [ 1383562.121196899563074, 5854710.149933977983892 ], [ 1383469.354954571928829, 5854710.149933977983892 ], [ 1383376.588712244294584, 5854575.479649240151048 ], [ 1383283.822469916660339, 5854440.811425729654729 ], [ 1383191.056227589026093, 5854440.811425729654729 ] ] } } -======= -{ "type": "Feature", "properties": { "width": 60.500781333333329, "branchtype": "river", "bedlev": 849.79998779296875, "height": 24.5, "branchid": "river_1", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_1", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1393117.044156666612253, 5866704.071640181355178 ], [ 1393024.277914338745177, 5866704.071640181355178 ], [ 1392931.511672010878101, 5866704.071640181355178 ], [ 1392838.745429683011025, 5866704.071640181355178 ], [ 1392745.979187355143949, 5866569.217538605444133 ], [ 1392653.212945027276874, 5866569.217538605444133 ], [ 1392560.446702699409798, 5866569.217538605444133 ], [ 1392467.680460371775553, 5866569.217538605444133 ], [ 1392374.914218043908477, 5866569.217538605444133 ], [ 1392282.147975716041401, 5866434.365506432019174 ], [ 1392189.381733388174325, 5866299.515543566085398 ], [ 1392096.615491060307249, 5866299.515543566085398 ], [ 1392003.849248732440174, 5866299.515543566085398 ], [ 1391911.083006404573098, 5866299.515543566085398 ], [ 1391818.316764076706022, 5866164.667649917304516 ], [ 1391725.550521749071777, 5866164.667649917304516 ], [ 1391632.784279421204701, 5866164.667649917304516 ], [ 1391540.018037093337625, 5866164.667649917304516 ], [ 1391447.251794765470549, 5866164.667649917304516 ], [ 1391354.485552437603474, 5866164.667649917304516 ], [ 1391261.719310109736398, 5866164.667649917304516 ], [ 1391168.953067781869322, 5866164.667649917304516 ], [ 1391076.186825454002246, 5866164.667649917304516 ], [ 1390983.42058312613517, 5866164.667649917304516 ], [ 1390890.654340798500925, 5866164.667649917304516 ], [ 1390797.88809847063385, 5866029.821825393475592 ], [ 1390705.121856142766774, 5866029.821825393475592 ], [ 1390612.355613814899698, 5866029.821825393475592 ], [ 1390519.589371487032622, 5866029.821825393475592 ], [ 1390426.823129159165546, 5866029.821825393475592 ], [ 1390334.05688683129847, 5866029.821825393475592 ], [ 1390241.290644503431395, 5866029.821825393475592 ], [ 1390148.524402175564319, 5865894.978069900535047 ], [ 1390055.758159847930074, 5865894.978069900535047 ], [ 1389962.991917520062998, 5865760.136383350938559 ], [ 1389870.225675192195922, 5865760.136383350938559 ], [ 1389777.459432864328846, 5865760.136383350938559 ], [ 1389684.693190536461771, 5865760.136383350938559 ], [ 1389591.926948208594695, 5865760.136383350938559 ], [ 1389499.160705880727619, 5865625.296765648759902 ], [ 1389406.394463552860543, 5865625.296765648759902 ], [ 1389406.394463552860543, 5865490.459216703660786 ], [ 1389313.628221225226298, 5865355.623736422508955 ], [ 1389313.628221225226298, 5865220.790324714966118 ], [ 1389313.628221225226298, 5865085.958981487900019 ], [ 1389220.861978897359222, 5864951.129706649109721 ], [ 1389128.095736569492146, 5864816.302500107325613 ], [ 1389128.095736569492146, 5864681.477361768484116 ], [ 1389035.329494241625071, 5864546.654291545040905 ], [ 1389128.095736569492146, 5864411.833289341069758 ], [ 1389128.095736569492146, 5864277.014355066232383 ], [ 1389035.329494241625071, 5864142.197488628327847 ], [ 1388942.563251913757995, 5864007.382689935155213 ], [ 1388849.797009585890919, 5863872.56995889544487 ], [ 1388757.030767258023843, 5863872.56995889544487 ], [ 1388664.264524930156767, 5863737.759295415133238 ], [ 1388571.498282602289692, 5863602.950699404813349 ], [ 1388571.498282602289692, 5863468.144170772284269 ], [ 1388571.498282602289692, 5863333.339709425345063 ], [ 1388478.732040274655446, 5863333.339709425345063 ], [ 1388385.965797946788371, 5863198.537315271794796 ], [ 1388293.199555618921295, 5863198.537315271794796 ], [ 1388200.433313291054219, 5863198.537315271794796 ], [ 1388107.667070963187143, 5863063.73698821850121 ], [ 1388014.900828635320067, 5863063.73698821850121 ], [ 1387922.134586307452992, 5863063.73698821850121 ], [ 1387829.368343979585916, 5862928.938728175126016 ], [ 1387736.60210165171884, 5862794.142535049468279 ], [ 1387736.60210165171884, 5862659.348408750258386 ], [ 1387736.60210165171884, 5862524.55634918436408 ], [ 1387643.835859324084595, 5862389.766356258653104 ], [ 1387551.069616996217519, 5862254.978429885581136 ], [ 1387458.303374668350443, 5862254.978429885581136 ], [ 1387365.537132340483367, 5862254.978429885581136 ], [ 1387272.770890012616292, 5862254.978429885581136 ], [ 1387180.004647684749216, 5862254.978429885581136 ], [ 1387087.23840535688214, 5862254.978429885581136 ], [ 1386994.472163029015064, 5862120.19256996922195 ] ] } }, -{ "type": "Feature", "properties": { "width": 63.595319, "branchtype": "river", "bedlev": 789.5, "height": 15.025009155273438, "branchid": "river_2", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_2", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1387829.368343979585916, 5866704.071640181355178 ], [ 1387829.368343979585916, 5866569.217538605444133 ], [ 1387922.134586307452992, 5866434.365506432019174 ], [ 1387922.134586307452992, 5866299.515543566085398 ], [ 1388014.900828635320067, 5866164.667649917304516 ], [ 1388014.900828635320067, 5866029.821825393475592 ], [ 1388014.900828635320067, 5865894.978069900535047 ], [ 1388014.900828635320067, 5865760.136383350938559 ], [ 1387922.134586307452992, 5865625.296765648759902 ], [ 1387922.134586307452992, 5865490.459216703660786 ], [ 1387922.134586307452992, 5865355.623736422508955 ], [ 1387922.134586307452992, 5865220.790324714966118 ], [ 1387922.134586307452992, 5865085.958981487900019 ], [ 1387829.368343979585916, 5864951.129706649109721 ], [ 1387829.368343979585916, 5864816.302500107325613 ], [ 1387829.368343979585916, 5864681.477361768484116 ], [ 1387829.368343979585916, 5864546.654291545040905 ], [ 1387829.368343979585916, 5864411.833289341069758 ], [ 1387829.368343979585916, 5864277.014355066232383 ], [ 1387736.60210165171884, 5864142.197488628327847 ], [ 1387643.835859324084595, 5864007.382689935155213 ], [ 1387551.069616996217519, 5863872.56995889544487 ], [ 1387551.069616996217519, 5863737.759295415133238 ], [ 1387458.303374668350443, 5863602.950699404813349 ], [ 1387365.537132340483367, 5863468.144170772284269 ], [ 1387272.770890012616292, 5863333.339709425345063 ], [ 1387272.770890012616292, 5863198.537315271794796 ], [ 1387180.004647684749216, 5863063.73698821850121 ], [ 1387087.23840535688214, 5862928.938728175126016 ], [ 1386994.472163029015064, 5862794.142535049468279 ], [ 1386901.705920701380819, 5862794.142535049468279 ], [ 1386808.939678373513743, 5862659.348408750258386 ], [ 1386716.173436045646667, 5862524.55634918436408 ], [ 1386716.173436045646667, 5862389.766356258653104 ], [ 1386716.173436045646667, 5862254.978429885581136 ], [ 1386808.939678373513743, 5862254.978429885581136 ], [ 1386901.705920701380819, 5862120.19256996922195 ], [ 1386994.472163029015064, 5862120.19256996922195 ] ] } }, -{ "type": "Feature", "properties": { "width": 50.0, "branchtype": "river", "bedlev": 952.79998779296875, "height": 21.70001220703125, "branchid": "river_3", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_3", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1391540.018037093337625, 5858077.577220032922924 ], [ 1391447.251794765470549, 5858077.577220032922924 ], [ 1391354.485552437603474, 5858077.577220032922924 ], [ 1391261.719310109736398, 5858077.577220032922924 ], [ 1391168.953067781869322, 5858077.577220032922924 ], [ 1391076.186825454002246, 5858212.301128901541233 ], [ 1390983.42058312613517, 5858212.301128901541233 ], [ 1390890.654340798500925, 5858212.301128901541233 ], [ 1390797.88809847063385, 5858077.577220032922924 ], [ 1390705.121856142766774, 5858077.577220032922924 ], [ 1390612.355613814899698, 5858077.577220032922924 ], [ 1390519.589371487032622, 5858077.577220032922924 ], [ 1390426.823129159165546, 5858077.577220032922924 ], [ 1390334.05688683129847, 5857942.855374775826931 ], [ 1390241.290644503431395, 5857942.855374775826931 ], [ 1390148.524402175564319, 5857942.855374775826931 ], [ 1390055.758159847930074, 5857808.135593039914966 ], [ 1389962.991917520062998, 5857808.135593039914966 ], [ 1389962.991917520062998, 5857673.417874733917415 ], [ 1389870.225675192195922, 5857673.417874733917415 ], [ 1389777.459432864328846, 5857673.417874733917415 ], [ 1389684.693190536461771, 5857808.135593039914966 ], [ 1389591.926948208594695, 5857808.135593039914966 ], [ 1389499.160705880727619, 5857808.135593039914966 ], [ 1389406.394463552860543, 5857808.135593039914966 ], [ 1389313.628221225226298, 5857942.855374775826931 ], [ 1389220.861978897359222, 5858077.577220032922924 ], [ 1389128.095736569492146, 5858212.301128901541233 ], [ 1389035.329494241625071, 5858212.301128901541233 ], [ 1388942.563251913757995, 5858347.02710147574544 ], [ 1388849.797009585890919, 5858347.02710147574544 ], [ 1388757.030767258023843, 5858347.02710147574544 ], [ 1388664.264524930156767, 5858481.75513784494251 ], [ 1388571.498282602289692, 5858481.75513784494251 ], [ 1388478.732040274655446, 5858481.75513784494251 ], [ 1388385.965797946788371, 5858481.75513784494251 ], [ 1388293.199555618921295, 5858481.75513784494251 ], [ 1388200.433313291054219, 5858616.485238100402057 ], [ 1388107.667070963187143, 5858751.217402335256338 ], [ 1388014.900828635320067, 5858885.951630644500256 ], [ 1387922.134586307452992, 5858885.951630644500256 ], [ 1387829.368343979585916, 5858885.951630644500256 ], [ 1387736.60210165171884, 5858885.951630644500256 ], [ 1387643.835859324084595, 5858885.951630644500256 ], [ 1387551.069616996217519, 5858885.951630644500256 ], [ 1387458.303374668350443, 5858885.951630644500256 ], [ 1387365.537132340483367, 5858885.951630644500256 ], [ 1387272.770890012616292, 5858885.951630644500256 ], [ 1387180.004647684749216, 5858885.951630644500256 ], [ 1387087.23840535688214, 5858885.951630644500256 ], [ 1386994.472163029015064, 5858885.951630644500256 ], [ 1386901.705920701380819, 5858885.951630644500256 ], [ 1386808.939678373513743, 5858885.951630644500256 ], [ 1386716.173436045646667, 5859020.687923113815486 ], [ 1386623.407193717779592, 5859020.687923113815486 ], [ 1386530.640951389912516, 5859020.687923113815486 ], [ 1386437.87470906204544, 5859020.687923113815486 ], [ 1386345.108466734178364, 5859020.687923113815486 ] ] } }, -{ "type": "Feature", "properties": { "width": 60.93007025, "branchtype": "river", "bedlev": 724.29998779296875, "height": 14.050003051757812, "branchid": "river_4", "branchorder": "1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_4", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386994.472163029015064, 5862120.19256996922195 ], [ 1386901.705920701380819, 5861985.408776419237256 ], [ 1386808.939678373513743, 5861850.62704914342612 ], [ 1386716.173436045646667, 5861715.847388052381575 ], [ 1386716.173436045646667, 5861581.069793050177395 ], [ 1386716.173436045646667, 5861446.294264047406614 ], [ 1386648.271799877518788, 5861347.644815167412162 ] ] } }, -{ "type": "Feature", "properties": { "width": 60.93007025, "branchtype": "river", "bedlev": 724.29998779296875, "height": 14.050003051757812, "branchid": "river_4-1", "branchorder": "1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_4", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386648.271799877518788, 5861347.644815167412162 ], [ 1386623.407193717779592, 5861311.520800950936973 ], [ 1386623.407193717779592, 5861176.749403670430183 ], [ 1386530.640951389912516, 5861176.749403670430183 ], [ 1386437.87470906204544, 5861041.98007211368531 ], [ 1386437.87470906204544, 5860907.21280618570745 ], [ 1386437.87470906204544, 5860772.447605800814927 ], [ 1386437.87470906204544, 5860637.684470860287547 ], [ 1386345.108466734178364, 5860502.923401278443635 ], [ 1386345.108466734178364, 5860368.164396960288286 ], [ 1386252.342224406311288, 5860233.40745781455189 ], [ 1386159.575982078444213, 5860098.652583749964833 ], [ 1386159.575982078444213, 5859963.899774672463536 ], [ 1386159.575982078444213, 5859829.149030492641032 ], [ 1386159.575982078444213, 5859694.400351119227707 ], [ 1386252.342224406311288, 5859559.653736458159983 ], [ 1386252.342224406311288, 5859424.909186419099569 ], [ 1386252.342224406311288, 5859290.166700908914208 ], [ 1386252.342224406311288, 5859155.426279838196933 ], [ 1386345.108466734178364, 5859020.687923113815486 ] ] } }, -{ "type": "Feature", "properties": { "width": 60.93007025, "branchtype": "river", "bedlev": 701.4000244140625, "height": 15.174972534179688, "branchid": "river_5", "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_5", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386345.108466734178364, 5859020.687923113815486 ], [ 1386252.342224406311288, 5858885.951630644500256 ], [ 1386159.575982078444213, 5858751.217402335256338 ], [ 1386159.575982078444213, 5858616.485238100402057 ], [ 1386159.575982078444213, 5858481.75513784494251 ], [ 1386159.575982078444213, 5858347.02710147574544 ], [ 1386066.809739750809968, 5858212.301128901541233 ], [ 1385974.043497422942892, 5858212.301128901541233 ], [ 1385881.277255095075816, 5858212.301128901541233 ], [ 1385788.51101276720874, 5858212.301128901541233 ], [ 1385695.744770439341664, 5858212.301128901541233 ], [ 1385602.978528111474589, 5858077.577220032922924 ], [ 1385510.212285783607513, 5857942.855374775826931 ], [ 1385510.212285783607513, 5857808.135593039914966 ], [ 1385417.446043455740437, 5857673.417874733917415 ], [ 1385324.679801127873361, 5857673.417874733917415 ], [ 1385231.913558800239116, 5857538.7022197637707 ], [ 1385231.913558800239116, 5857403.988628040067852 ], [ 1385231.913558800239116, 5857269.277099470607936 ], [ 1385231.913558800239116, 5857134.567633963190019 ], [ 1385324.679801127873361, 5856999.860231426544487 ], [ 1385231.913558800239116, 5856865.154891768470407 ], [ 1385231.913558800239116, 5856730.451614897698164 ], [ 1385139.14731647237204, 5856595.750400722026825 ], [ 1385046.381074144504964, 5856595.750400722026825 ], [ 1384953.614831816637889, 5856461.0512491511181 ], [ 1384860.848589488770813, 5856461.0512491511181 ], [ 1384768.082347160903737, 5856326.354160091839731 ], [ 1384768.082347160903737, 5856191.659133451990783 ], [ 1384675.316104833036661, 5856056.966169143095613 ], [ 1384582.549862505169585, 5856056.966169143095613 ], [ 1384489.78362017753534, 5855922.275267072021961 ], [ 1384397.017377849668264, 5855787.586427142843604 ], [ 1384304.251135521801189, 5855787.586427142843604 ], [ 1384211.484893193934113, 5855652.899649270810187 ], [ 1384118.718650866067037, 5855518.214933359995484 ] ] } } ->>>>>>> main +{ "type": "Feature", "properties": { "branchtype": "river", "bedlev": 849.79998779296875, "branchid": "river_1", "width": 60.500781333333329, "height": 24.5, "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_1", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1393117.044156666612253, 5866704.071640181355178 ], [ 1393024.277914338745177, 5866704.071640181355178 ], [ 1392931.511672010878101, 5866704.071640181355178 ], [ 1392838.745429683011025, 5866704.071640181355178 ], [ 1392745.979187355143949, 5866569.217538605444133 ], [ 1392653.212945027276874, 5866569.217538605444133 ], [ 1392560.446702699409798, 5866569.217538605444133 ], [ 1392467.680460371775553, 5866569.217538605444133 ], [ 1392374.914218043908477, 5866569.217538605444133 ], [ 1392282.147975716041401, 5866434.365506432019174 ], [ 1392189.381733388174325, 5866299.515543566085398 ], [ 1392096.615491060307249, 5866299.515543566085398 ], [ 1392003.849248732440174, 5866299.515543566085398 ], [ 1391911.083006404573098, 5866299.515543566085398 ], [ 1391818.316764076706022, 5866164.667649917304516 ], [ 1391725.550521749071777, 5866164.667649917304516 ], [ 1391632.784279421204701, 5866164.667649917304516 ], [ 1391540.018037093337625, 5866164.667649917304516 ], [ 1391447.251794765470549, 5866164.667649917304516 ], [ 1391354.485552437603474, 5866164.667649917304516 ], [ 1391261.719310109736398, 5866164.667649917304516 ], [ 1391168.953067781869322, 5866164.667649917304516 ], [ 1391076.186825454002246, 5866164.667649917304516 ], [ 1390983.42058312613517, 5866164.667649917304516 ], [ 1390890.654340798500925, 5866164.667649917304516 ], [ 1390797.88809847063385, 5866029.821825393475592 ], [ 1390705.121856142766774, 5866029.821825393475592 ], [ 1390612.355613814899698, 5866029.821825393475592 ], [ 1390519.589371487032622, 5866029.821825393475592 ], [ 1390426.823129159165546, 5866029.821825393475592 ], [ 1390334.05688683129847, 5866029.821825393475592 ], [ 1390241.290644503431395, 5866029.821825393475592 ], [ 1390148.524402175564319, 5865894.978069900535047 ], [ 1390055.758159847930074, 5865894.978069900535047 ], [ 1389962.991917520062998, 5865760.136383350938559 ], [ 1389870.225675192195922, 5865760.136383350938559 ], [ 1389777.459432864328846, 5865760.136383350938559 ], [ 1389684.693190536461771, 5865760.136383350938559 ], [ 1389591.926948208594695, 5865760.136383350938559 ], [ 1389499.160705880727619, 5865625.296765648759902 ], [ 1389406.394463552860543, 5865625.296765648759902 ], [ 1389406.394463552860543, 5865490.459216703660786 ], [ 1389313.628221225226298, 5865355.623736422508955 ], [ 1389313.628221225226298, 5865220.790324714966118 ], [ 1389313.628221225226298, 5865085.958981487900019 ], [ 1389220.861978897359222, 5864951.129706649109721 ], [ 1389128.095736569492146, 5864816.302500107325613 ], [ 1389128.095736569492146, 5864681.477361768484116 ], [ 1389035.329494241625071, 5864546.654291545040905 ], [ 1389128.095736569492146, 5864411.833289341069758 ], [ 1389128.095736569492146, 5864277.014355066232383 ], [ 1389035.329494241625071, 5864142.197488628327847 ], [ 1388942.563251913757995, 5864007.382689935155213 ], [ 1388849.797009585890919, 5863872.56995889544487 ], [ 1388757.030767258023843, 5863872.56995889544487 ], [ 1388664.264524930156767, 5863737.759295415133238 ], [ 1388571.498282602289692, 5863602.950699404813349 ], [ 1388571.498282602289692, 5863468.144170772284269 ], [ 1388571.498282602289692, 5863333.339709425345063 ], [ 1388478.732040274655446, 5863333.339709425345063 ], [ 1388385.965797946788371, 5863198.537315271794796 ], [ 1388293.199555618921295, 5863198.537315271794796 ], [ 1388200.433313291054219, 5863198.537315271794796 ], [ 1388107.667070963187143, 5863063.73698821850121 ], [ 1388014.900828635320067, 5863063.73698821850121 ], [ 1387922.134586307452992, 5863063.73698821850121 ], [ 1387829.368343979585916, 5862928.938728175126016 ], [ 1387736.60210165171884, 5862794.142535049468279 ], [ 1387736.60210165171884, 5862659.348408750258386 ], [ 1387736.60210165171884, 5862524.55634918436408 ], [ 1387643.835859324084595, 5862389.766356258653104 ], [ 1387551.069616996217519, 5862254.978429885581136 ], [ 1387458.303374668350443, 5862254.978429885581136 ], [ 1387365.537132340483367, 5862254.978429885581136 ], [ 1387272.770890012616292, 5862254.978429885581136 ], [ 1387180.004647684749216, 5862254.978429885581136 ], [ 1387087.23840535688214, 5862254.978429885581136 ], [ 1386994.472163029015064, 5862120.19256996922195 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "bedlev": 789.5, "branchid": "river_2", "width": 63.595319, "height": 15.025009155273438, "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_2", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1387829.368343979585916, 5866704.071640181355178 ], [ 1387829.368343979585916, 5866569.217538605444133 ], [ 1387922.134586307452992, 5866434.365506432019174 ], [ 1387922.134586307452992, 5866299.515543566085398 ], [ 1388014.900828635320067, 5866164.667649917304516 ], [ 1388014.900828635320067, 5866029.821825393475592 ], [ 1388014.900828635320067, 5865894.978069900535047 ], [ 1388014.900828635320067, 5865760.136383350938559 ], [ 1387922.134586307452992, 5865625.296765648759902 ], [ 1387922.134586307452992, 5865490.459216703660786 ], [ 1387922.134586307452992, 5865355.623736422508955 ], [ 1387922.134586307452992, 5865220.790324714966118 ], [ 1387922.134586307452992, 5865085.958981487900019 ], [ 1387829.368343979585916, 5864951.129706649109721 ], [ 1387829.368343979585916, 5864816.302500107325613 ], [ 1387829.368343979585916, 5864681.477361768484116 ], [ 1387829.368343979585916, 5864546.654291545040905 ], [ 1387829.368343979585916, 5864411.833289341069758 ], [ 1387829.368343979585916, 5864277.014355066232383 ], [ 1387736.60210165171884, 5864142.197488628327847 ], [ 1387643.835859324084595, 5864007.382689935155213 ], [ 1387551.069616996217519, 5863872.56995889544487 ], [ 1387551.069616996217519, 5863737.759295415133238 ], [ 1387458.303374668350443, 5863602.950699404813349 ], [ 1387365.537132340483367, 5863468.144170772284269 ], [ 1387272.770890012616292, 5863333.339709425345063 ], [ 1387272.770890012616292, 5863198.537315271794796 ], [ 1387180.004647684749216, 5863063.73698821850121 ], [ 1387087.23840535688214, 5862928.938728175126016 ], [ 1386994.472163029015064, 5862794.142535049468279 ], [ 1386901.705920701380819, 5862794.142535049468279 ], [ 1386808.939678373513743, 5862659.348408750258386 ], [ 1386716.173436045646667, 5862524.55634918436408 ], [ 1386716.173436045646667, 5862389.766356258653104 ], [ 1386716.173436045646667, 5862254.978429885581136 ], [ 1386808.939678373513743, 5862254.978429885581136 ], [ 1386901.705920701380819, 5862120.19256996922195 ], [ 1386994.472163029015064, 5862120.19256996922195 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "bedlev": 952.79998779296875, "branchid": "river_3", "width": 50.0, "height": 21.70001220703125, "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_3", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1391540.018037093337625, 5858077.577220032922924 ], [ 1391447.251794765470549, 5858077.577220032922924 ], [ 1391354.485552437603474, 5858077.577220032922924 ], [ 1391261.719310109736398, 5858077.577220032922924 ], [ 1391168.953067781869322, 5858077.577220032922924 ], [ 1391076.186825454002246, 5858212.301128901541233 ], [ 1390983.42058312613517, 5858212.301128901541233 ], [ 1390890.654340798500925, 5858212.301128901541233 ], [ 1390797.88809847063385, 5858077.577220032922924 ], [ 1390705.121856142766774, 5858077.577220032922924 ], [ 1390612.355613814899698, 5858077.577220032922924 ], [ 1390519.589371487032622, 5858077.577220032922924 ], [ 1390426.823129159165546, 5858077.577220032922924 ], [ 1390334.05688683129847, 5857942.855374775826931 ], [ 1390241.290644503431395, 5857942.855374775826931 ], [ 1390148.524402175564319, 5857942.855374775826931 ], [ 1390055.758159847930074, 5857808.135593039914966 ], [ 1389962.991917520062998, 5857808.135593039914966 ], [ 1389962.991917520062998, 5857673.417874733917415 ], [ 1389870.225675192195922, 5857673.417874733917415 ], [ 1389777.459432864328846, 5857673.417874733917415 ], [ 1389684.693190536461771, 5857808.135593039914966 ], [ 1389591.926948208594695, 5857808.135593039914966 ], [ 1389499.160705880727619, 5857808.135593039914966 ], [ 1389406.394463552860543, 5857808.135593039914966 ], [ 1389313.628221225226298, 5857942.855374775826931 ], [ 1389220.861978897359222, 5858077.577220032922924 ], [ 1389128.095736569492146, 5858212.301128901541233 ], [ 1389035.329494241625071, 5858212.301128901541233 ], [ 1388942.563251913757995, 5858347.02710147574544 ], [ 1388849.797009585890919, 5858347.02710147574544 ], [ 1388757.030767258023843, 5858347.02710147574544 ], [ 1388664.264524930156767, 5858481.75513784494251 ], [ 1388571.498282602289692, 5858481.75513784494251 ], [ 1388478.732040274655446, 5858481.75513784494251 ], [ 1388385.965797946788371, 5858481.75513784494251 ], [ 1388293.199555618921295, 5858481.75513784494251 ], [ 1388200.433313291054219, 5858616.485238100402057 ], [ 1388107.667070963187143, 5858751.217402335256338 ], [ 1388014.900828635320067, 5858885.951630644500256 ], [ 1387922.134586307452992, 5858885.951630644500256 ], [ 1387829.368343979585916, 5858885.951630644500256 ], [ 1387736.60210165171884, 5858885.951630644500256 ], [ 1387643.835859324084595, 5858885.951630644500256 ], [ 1387551.069616996217519, 5858885.951630644500256 ], [ 1387458.303374668350443, 5858885.951630644500256 ], [ 1387365.537132340483367, 5858885.951630644500256 ], [ 1387272.770890012616292, 5858885.951630644500256 ], [ 1387180.004647684749216, 5858885.951630644500256 ], [ 1387087.23840535688214, 5858885.951630644500256 ], [ 1386994.472163029015064, 5858885.951630644500256 ], [ 1386901.705920701380819, 5858885.951630644500256 ], [ 1386808.939678373513743, 5858885.951630644500256 ], [ 1386716.173436045646667, 5859020.687923113815486 ], [ 1386623.407193717779592, 5859020.687923113815486 ], [ 1386530.640951389912516, 5859020.687923113815486 ], [ 1386437.87470906204544, 5859020.687923113815486 ], [ 1386345.108466734178364, 5859020.687923113815486 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "bedlev": 724.29998779296875, "branchid": "river_4", "width": 60.93007025, "height": 14.050003051757812, "branchorder": "1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_4", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386994.472163029015064, 5862120.19256996922195 ], [ 1386901.705920701380819, 5861985.408776419237256 ], [ 1386808.939678373513743, 5861850.62704914342612 ], [ 1386716.173436045646667, 5861715.847388052381575 ], [ 1386716.173436045646667, 5861581.069793050177395 ], [ 1386716.173436045646667, 5861446.294264047406614 ], [ 1386648.271799877518788, 5861347.644815167412162 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "bedlev": 724.29998779296875, "branchid": "river_4-1", "width": 60.93007025, "height": 14.050003051757812, "branchorder": "1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_4", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386648.271799877518788, 5861347.644815167412162 ], [ 1386623.407193717779592, 5861311.520800950936973 ], [ 1386623.407193717779592, 5861176.749403670430183 ], [ 1386530.640951389912516, 5861176.749403670430183 ], [ 1386437.87470906204544, 5861041.98007211368531 ], [ 1386437.87470906204544, 5860907.21280618570745 ], [ 1386437.87470906204544, 5860772.447605800814927 ], [ 1386437.87470906204544, 5860637.684470860287547 ], [ 1386345.108466734178364, 5860502.923401278443635 ], [ 1386345.108466734178364, 5860368.164396960288286 ], [ 1386252.342224406311288, 5860233.40745781455189 ], [ 1386159.575982078444213, 5860098.652583749964833 ], [ 1386159.575982078444213, 5859963.899774672463536 ], [ 1386159.575982078444213, 5859829.149030492641032 ], [ 1386159.575982078444213, 5859694.400351119227707 ], [ 1386252.342224406311288, 5859559.653736458159983 ], [ 1386252.342224406311288, 5859424.909186419099569 ], [ 1386252.342224406311288, 5859290.166700908914208 ], [ 1386252.342224406311288, 5859155.426279838196933 ], [ 1386345.108466734178364, 5859020.687923113815486 ] ] } }, +{ "type": "Feature", "properties": { "branchtype": "river", "bedlev": 701.4000244140625, "branchid": "river_5", "width": 60.93007025, "height": 15.174972534179688, "branchorder": "-1", "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_5", "frictiontype": "Manning", "frictionvalue": 0.023, "frictionid": "Manning_0.023", "index": null, "diameter": null, "index_right": null, "elevtn_up": null, "elevtn_dn": null, "invlev_up": null, "invlev_dn": null, "manhole_up": null, "manhole_dn": null }, "geometry": { "type": "LineString", "coordinates": [ [ 1386345.108466734178364, 5859020.687923113815486 ], [ 1386252.342224406311288, 5858885.951630644500256 ], [ 1386159.575982078444213, 5858751.217402335256338 ], [ 1386159.575982078444213, 5858616.485238100402057 ], [ 1386159.575982078444213, 5858481.75513784494251 ], [ 1386159.575982078444213, 5858347.02710147574544 ], [ 1386066.809739750809968, 5858212.301128901541233 ], [ 1385974.043497422942892, 5858212.301128901541233 ], [ 1385881.277255095075816, 5858212.301128901541233 ], [ 1385788.51101276720874, 5858212.301128901541233 ], [ 1385695.744770439341664, 5858212.301128901541233 ], [ 1385602.978528111474589, 5858077.577220032922924 ], [ 1385510.212285783607513, 5857942.855374775826931 ], [ 1385510.212285783607513, 5857808.135593039914966 ], [ 1385417.446043455740437, 5857673.417874733917415 ], [ 1385324.679801127873361, 5857673.417874733917415 ], [ 1385231.913558800239116, 5857538.7022197637707 ], [ 1385231.913558800239116, 5857403.988628040067852 ], [ 1385231.913558800239116, 5857269.277099470607936 ], [ 1385231.913558800239116, 5857134.567633963190019 ], [ 1385324.679801127873361, 5856999.860231426544487 ], [ 1385231.913558800239116, 5856865.154891768470407 ], [ 1385231.913558800239116, 5856730.451614897698164 ], [ 1385139.14731647237204, 5856595.750400722026825 ], [ 1385046.381074144504964, 5856595.750400722026825 ], [ 1384953.614831816637889, 5856461.0512491511181 ], [ 1384860.848589488770813, 5856461.0512491511181 ], [ 1384768.082347160903737, 5856326.354160091839731 ], [ 1384768.082347160903737, 5856191.659133451990783 ], [ 1384675.316104833036661, 5856056.966169143095613 ], [ 1384582.549862505169585, 5856056.966169143095613 ], [ 1384489.78362017753534, 5855922.275267072021961 ], [ 1384397.017377849668264, 5855787.586427142843604 ], [ 1384304.251135521801189, 5855787.586427142843604 ], [ 1384211.484893193934113, 5855652.899649270810187 ], [ 1384118.718650866067037, 5855518.214933359995484 ] ] } } ] } diff --git a/examples/dflowfm_piave/geoms/rivers_nodes.geojson b/examples/dflowfm_piave/geoms/rivers_nodes.geojson index c2a515d0..7ea1ad55 100644 --- a/examples/dflowfm_piave/geoms/rivers_nodes.geojson +++ b/examples/dflowfm_piave/geoms/rivers_nodes.geojson @@ -2,20 +2,11 @@ "type": "FeatureCollection", "crs": { "type": "name", "properties": { "name": "urn:ogc:def:crs:EPSG::3857" } }, "features": [ -<<<<<<< HEAD -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_0", "branch_id": "river_1", "height": 22.5, "bedlev": 865.60003662109375, "width": 60.500781333333329, "branchid": "river_1", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_1" }, "geometry": { "type": "Point", "coordinates": [ 1394694.070276216836646, 5867648.108302162960172 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_1", "branch_id": "river_1", "height": 22.5, "bedlev": 865.60003662109375, "width": 60.500781333333329, "branchid": "river_1", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_1" }, "geometry": { "type": "Point", "coordinates": [ 1386994.472163022495806, 5862120.192569970153272 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_2", "branch_id": "river_2", "height": 13.574996948242188, "bedlev": 813.29998779296875, "width": 63.595319, "branchid": "river_2", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_2" }, "geometry": { "type": "Point", "coordinates": [ 1386066.809739745920524, 5868052.726493230089545 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_3", "branch_id": "river_3", "height": 21.70001220703125, "bedlev": 952.79998779296875, "width": 50.0, "branchid": "river_3", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_3" }, "geometry": { "type": "Point", "coordinates": [ 1391540.01803707703948, 5858077.577220032922924 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_4", "branch_id": "river_3", "height": 21.70001220703125, "bedlev": 952.79998779296875, "width": 50.0, "branchid": "river_3", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_3" }, "geometry": { "type": "Point", "coordinates": [ 1386345.108466728823259, 5859020.687923114746809 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_5", "branch_id": "river_5", "height": 17.349960327148438, "bedlev": 701.4000244140625, "width": 60.93007025, "branchid": "river_5", "branchtype": "river", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "frictiontype": "Manning", "frictionvalue": 0.023, "ORIG_branchid": "river_5" }, "geometry": { "type": "Point", "coordinates": [ 1383191.056227589026093, 5854440.811425729654729 ] } } -======= -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_0", "branch_id": "river_1", "width": 60.500781333333329, "branchtype": "river", "bedlev": 849.79998779296875, "height": 24.5, "branchid": "river_1", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_1" }, "geometry": { "type": "Point", "coordinates": [ 1393117.044156666612253, 5866704.071640181355178 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_1", "branch_id": "river_1", "width": 60.500781333333329, "branchtype": "river", "bedlev": 849.79998779296875, "height": 24.5, "branchid": "river_1", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_1" }, "geometry": { "type": "Point", "coordinates": [ 1386994.472163029015064, 5862120.19256996922195 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_2", "branch_id": "river_2", "width": 63.595319, "branchtype": "river", "bedlev": 789.5, "height": 15.025009155273438, "branchid": "river_2", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_2" }, "geometry": { "type": "Point", "coordinates": [ 1387829.368343979585916, 5866704.071640181355178 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_3", "branch_id": "river_3", "width": 50.0, "branchtype": "river", "bedlev": 952.79998779296875, "height": 21.70001220703125, "branchid": "river_3", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_3" }, "geometry": { "type": "Point", "coordinates": [ 1391540.018037093337625, 5858077.577220032922924 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_4", "branch_id": "river_3", "width": 50.0, "branchtype": "river", "bedlev": 952.79998779296875, "height": 21.70001220703125, "branchid": "river_3", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_3" }, "geometry": { "type": "Point", "coordinates": [ 1386345.108466734178364, 5859020.687923113815486 ] } }, -{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_5", "branch_id": "river_5", "width": 60.93007025, "branchtype": "river", "bedlev": 701.4000244140625, "height": 15.174972534179688, "branchid": "river_5", "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_5" }, "geometry": { "type": "Point", "coordinates": [ 1384118.718650866067037, 5855518.214933359995484 ] } } ->>>>>>> main +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_0", "branch_id": "river_1", "branchtype": "river", "bedlev": 849.79998779296875, "branchid": "river_1", "width": 60.500781333333329, "height": 24.5, "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_1" }, "geometry": { "type": "Point", "coordinates": [ 1393117.044156666612253, 5866704.071640181355178 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_1", "branch_id": "river_1", "branchtype": "river", "bedlev": 849.79998779296875, "branchid": "river_1", "width": 60.500781333333329, "height": 24.5, "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_1" }, "geometry": { "type": "Point", "coordinates": [ 1386994.472163029015064, 5862120.19256996922195 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_2", "branch_id": "river_2", "branchtype": "river", "bedlev": 789.5, "branchid": "river_2", "width": 63.595319, "height": 15.025009155273438, "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_2" }, "geometry": { "type": "Point", "coordinates": [ 1387829.368343979585916, 5866704.071640181355178 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_3", "branch_id": "river_3", "branchtype": "river", "bedlev": 952.79998779296875, "branchid": "river_3", "width": 50.0, "height": 21.70001220703125, "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_3" }, "geometry": { "type": "Point", "coordinates": [ 1391540.018037093337625, 5858077.577220032922924 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_4", "branch_id": "river_3", "branchtype": "river", "bedlev": 952.79998779296875, "branchid": "river_3", "width": 50.0, "height": 21.70001220703125, "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_3" }, "geometry": { "type": "Point", "coordinates": [ 1386345.108466734178364, 5859020.687923113815486 ] } }, +{ "type": "Feature", "properties": { "branchnodeid": "branchnodes_5", "branch_id": "river_5", "branchtype": "river", "bedlev": 701.4000244140625, "branchid": "river_5", "width": 60.93007025, "height": 15.174972534179688, "branchorder": -1.0, "friction_type": "Manning", "friction_value": 0.023, "shape": "rectangle", "t_width": 20.0, "closed": "no", "ORIG_branchid": "river_5" }, "geometry": { "type": "Point", "coordinates": [ 1384118.718650866067037, 5855518.214933359995484 ] } } ] } From b15e96d11cc39f54d2bd6b50252632605d129c94 Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Tue, 24 Oct 2023 10:31:08 +0200 Subject: [PATCH 21/32] add missing commit --- .../dflowfm/boundarycondition1d.bc | 78 +++++++++ examples/dflowfm_local/dflowfm/lateral1d.bc | 78 +++++++++ .../dflowfm/roughness_Manning_0.023.ini | 11 ++ .../roughness_WhiteColeBrook_0.003.ini | 11 ++ examples/dflowfm_local/hydromt_data.yml | 165 ++++++++++++++++++ .../dflowfm/boundarycondition1d.bc | 42 +++++ .../dflowfm/roughness_Manning_0.023.ini | 11 ++ .../roughness_WhiteColeBrook_0.003.ini | 11 ++ examples/dflowfm_piave/hydromt_data.yml | 78 +++++++++ 9 files changed, 485 insertions(+) create mode 100644 examples/dflowfm_local/dflowfm/boundarycondition1d.bc create mode 100644 examples/dflowfm_local/dflowfm/lateral1d.bc create mode 100644 examples/dflowfm_local/dflowfm/roughness_Manning_0.023.ini create mode 100644 examples/dflowfm_local/dflowfm/roughness_WhiteColeBrook_0.003.ini create mode 100644 examples/dflowfm_local/hydromt_data.yml create mode 100644 examples/dflowfm_piave/dflowfm/boundarycondition1d.bc create mode 100644 examples/dflowfm_piave/dflowfm/roughness_Manning_0.023.ini create mode 100644 examples/dflowfm_piave/dflowfm/roughness_WhiteColeBrook_0.003.ini create mode 100644 examples/dflowfm_piave/hydromt_data.yml diff --git a/examples/dflowfm_local/dflowfm/boundarycondition1d.bc b/examples/dflowfm_local/dflowfm/boundarycondition1d.bc new file mode 100644 index 00000000..e8d29391 --- /dev/null +++ b/examples/dflowfm_local/dflowfm/boundarycondition1d.bc @@ -0,0 +1,78 @@ +# written by HYDROLIB-core 0.5.2 + +[General] +fileVersion = 1.01 +fileType = boundConds + +[Forcing] +name = 664197.234160_1527152.705985 +function = timeseries +timeInterpolation = linear +offset = 0.0 +factor = 1.0 +quantity = time +unit = hours since 2020-01-01 00:00:00 +quantity = waterlevelbnd +unit = m +0.0 -1.0 +1.0 -1.0 +2.0 -1.0 +3.0 -1.0 +4.0 -1.0 +5.0 -1.0 +6.0 -1.0 +7.0 -1.0 +8.0 -1.0 +9.0 -1.0 +10.0 -1.0 +11.0 -1.0 +12.0 -1.0 +13.0 -1.0 +14.0 -1.0 +15.0 -1.0 +16.0 -1.0 +17.0 -1.0 +18.0 -1.0 +19.0 -1.0 +20.0 -1.0 +21.0 -1.0 +22.0 -1.0 +23.0 -1.0 +24.0 -1.0 + +[Forcing] +name = 666180.040000_1525894.770000 +function = timeseries +timeInterpolation = linear +offset = 0.0 +factor = 1.0 +quantity = time +unit = hours since 2020-01-01 00:00:00 +quantity = waterlevelbnd +unit = m +0.0 0.0 +1.0 0.0 +2.0 0.0 +3.0 0.0 +4.0 0.0 +5.0 0.0 +6.0 0.0 +7.0 0.0 +8.0 0.0 +9.0 0.0 +10.0 0.0 +11.0 0.0 +12.0 0.0 +13.0 0.0 +14.0 0.0 +15.0 0.0 +16.0 0.0 +17.0 0.0 +18.0 0.0 +19.0 0.0 +20.0 0.0 +21.0 0.0 +22.0 0.0 +23.0 0.0 +24.0 0.0 + diff --git a/examples/dflowfm_local/dflowfm/lateral1d.bc b/examples/dflowfm_local/dflowfm/lateral1d.bc new file mode 100644 index 00000000..878e7577 --- /dev/null +++ b/examples/dflowfm_local/dflowfm/lateral1d.bc @@ -0,0 +1,78 @@ +# written by HYDROLIB-core 0.5.2 + +[General] +fileVersion = 1.01 +fileType = boundConds + +[Forcing] +name = lateral1d_points_0 +function = timeseries +timeInterpolation = linear +offset = 0.0 +factor = 1.0 +quantity = time +unit = hours since 2020-01-01 00:00:00 +quantity = lateral_discharge +unit = m3/s +0.0 0.0 +1.0 0.0 +2.0 0.0 +3.0 0.0 +4.0 0.0 +5.0 0.0 +6.0 0.0 +7.0 0.0 +8.0 0.0 +9.0 0.0 +10.0 0.0 +11.0 0.0 +12.0 0.0 +13.0 0.0 +14.0 0.0 +15.0 0.0 +16.0 0.0 +17.0 0.0 +18.0 0.0 +19.0 0.0 +20.0 0.0 +21.0 0.0 +22.0 0.0 +23.0 0.0 +24.0 0.0 + +[Forcing] +name = lateral1d_polygons_0 +function = timeseries +timeInterpolation = linear +offset = 0.0 +factor = 1.0 +quantity = time +unit = hours since 2020-01-01 00:00:00 +quantity = lateral_discharge +unit = m3/s +0.0 0.0 +1.0 0.0 +2.0 0.0 +3.0 0.0 +4.0 0.0 +5.0 0.0 +6.0 0.0 +7.0 0.0 +8.0 0.0 +9.0 0.0 +10.0 0.0 +11.0 0.0 +12.0 0.0 +13.0 0.0 +14.0 0.0 +15.0 0.0 +16.0 0.0 +17.0 0.0 +18.0 0.0 +19.0 0.0 +20.0 0.0 +21.0 0.0 +22.0 0.0 +23.0 0.0 +24.0 0.0 + diff --git a/examples/dflowfm_local/dflowfm/roughness_Manning_0.023.ini b/examples/dflowfm_local/dflowfm/roughness_Manning_0.023.ini new file mode 100644 index 00000000..7e9eaa31 --- /dev/null +++ b/examples/dflowfm_local/dflowfm/roughness_Manning_0.023.ini @@ -0,0 +1,11 @@ +# written by HYDROLIB-core 0.5.2 + +[General] +fileVersion = 3.01 # File version. Do not edit this. +fileType = roughness # File type. Should be 'roughness'. Do not edit this. + +[Global] +frictionId = Manning_0.023 # Name of the roughness variable. +frictionType = Manning # The global roughness type for this variable, which is used if no branch specific roughness definition is given. +frictionValue = 0.023 # The global default value for this roughness variable. + diff --git a/examples/dflowfm_local/dflowfm/roughness_WhiteColeBrook_0.003.ini b/examples/dflowfm_local/dflowfm/roughness_WhiteColeBrook_0.003.ini new file mode 100644 index 00000000..f5f445fb --- /dev/null +++ b/examples/dflowfm_local/dflowfm/roughness_WhiteColeBrook_0.003.ini @@ -0,0 +1,11 @@ +# written by HYDROLIB-core 0.5.2 + +[General] +fileVersion = 3.01 # File version. Do not edit this. +fileType = roughness # File type. Should be 'roughness'. Do not edit this. + +[Global] +frictionId = WhiteColeBrook_0.003 # Name of the roughness variable. +frictionType = WhiteColebrook # The global roughness type for this variable, which is used if no branch specific roughness definition is given. +frictionValue = 0.003 # The global default value for this roughness variable. + diff --git a/examples/dflowfm_local/hydromt_data.yml b/examples/dflowfm_local/hydromt_data.yml new file mode 100644 index 00000000..e4153c7f --- /dev/null +++ b/examples/dflowfm_local/hydromt_data.yml @@ -0,0 +1,165 @@ +1D_boundaries_timeseries: + data_type: GeoDataset + path: c:\Developments\hydromt_delft3dfm\tests\data\local_data\boundaries.geojson + driver: vector + driver_kwargs: + fn_data: c:\Developments\hydromt_delft3dfm\tests\data\local_data\boundaries_series.csv + crs: 32647 +1D_branches: + data_type: GeoDataFrame + path: c:\Developments\hydromt_delft3dfm\tests\data\local_data\1D_rivers.geojson + driver: vector + rename: + BRANCH_ID: branchid + BR_TYPE: branchtype + crs: 32647 +1D_bridges_defaults: + data_type: DataFrame + path: c:\Developments\hydromt_delft3dfm\hydromt_delft3dfm\data\structures\bridges_defaults.csv + driver: csv + meta: + notes: default bridge parameters. +1D_culverts_defaults: + data_type: DataFrame + path: c:\Developments\hydromt_delft3dfm\hydromt_delft3dfm\data\structures\culverts_defaults.csv + driver: csv + meta: + notes: default culvert parameters. +1D_laterals_polygons_timeseries: + data_type: GeoDataset + path: c:\Developments\hydromt_delft3dfm\tests\data\local_data\laterals_polygons.geojson + driver: vector + driver_kwargs: + fn_data: c:\Developments\hydromt_delft3dfm\tests\data\local_data\laterals_series.csv + assert_gtype: Polygon + rename: + 1D_laterals_polygons_timeseries: lateral_discharge + crs: 32647 +1D_laterals_timeseries: + data_type: GeoDataset + path: c:\Developments\hydromt_delft3dfm\tests\data\local_data\laterals_points.geojson + driver: vector + driver_kwargs: + fn_data: c:\Developments\hydromt_delft3dfm\tests\data\local_data\laterals_series.csv + rename: + 1D_laterals_timeseries: lateral_discharge + crs: 32647 +1D_rivers_pointcrosssections: + data_type: GeoDataFrame + path: c:\Developments\hydromt_delft3dfm\tests\data\local_data\1D_rivers_pointcrosssections.geojson + driver: vector + rename: + id: crsid + TYPE: shape + WIDTH: width + HEIGHT: height + BEDLEVEL: shift + crs: 32647 +1D_rivers_xyzcrosssections: + data_type: GeoDataFrame + path: c:\Developments\hydromt_delft3dfm\tests\data\local_data\1D_rivers_xyzcrosssections.geojson + driver: vector + rename: + ORDER: order + CRS_ID: crsid + Z: z + crs: 32647 +1d_bridges: + data_type: GeoDataFrame + path: c:\Developments\hydromt_delft3dfm\tests\data\local_data\bridges.geojson + driver: vector + rename: + STRUC_ID: structure_id + STRUC_TYPE: structure_type + SHAPE: shape + WIDTH: width + HEIGHT: height + CLOSED: closed + BEDLEV: shift + LENGTH: length + FLOW_DIR: allowedflowdir + IN_LOSS: inletlosscoeff + OUT_LOSS: outletlosscoeff + crs: 32647 +1d_culverts: + data_type: GeoDataFrame + path: c:\Developments\hydromt_delft3dfm\tests\data\local_data\culverts.geojson + driver: vector + rename: + STRUC_ID: structure_id + STRUC_TYPE: structure_type + SHAPE: shape + WIDTH: width + HEIGHT: height + CLOSED: closed + INVLEV_UP: leftlevel + INVLEV_DN: rightlevel + FLOW_DIR: allowedflowdir + crs: 32647 +1d_manholes: + data_type: GeoDataFrame + path: c:\Developments\hydromt_delft3dfm\tests\data\local_data\manholes.geojson + driver: vector + rename: + ID: manholeid + AREA: area + STR_AREA: streetArea + crs: 32647 +2D_boundary: + data_type: GeoDataFrame + path: c:\Developments\hydromt_delft3dfm\tests\data\local_data\2d_boundary.geojson + driver: vector + meta: + notes: created by buffer the extent by aqrt(2) * res. Must contain boundary_id + if timeseries is specified + crs: 32647 +2D_boundary_timeseries: + data_type: DataFrame + path: c:\Developments\hydromt_delft3dfm\tests\data\local_data\2dboundaries_series.csv + driver: csv + driver_kwargs: + index_col: time + parse_dates: true + dayfirst: true + meta: + notes: time series data for the 2D boundary, must contain time as index and boundary_id + as columns +dem: + data_type: RasterDataset + path: c:\Developments\hydromt_delft3dfm\tests\data\local_data\dem.tif + driver: raster + rename: + dem: elevtn + meta: + category: dem + history: temporary dem within model extent + crs: 4326 +manholes_defaults: + data_type: DataFrame + path: c:\Developments\hydromt_delft3dfm\hydromt_delft3dfm\data\storages\manholes_defaults.csv + driver: csv + meta: + notes: default manhole parameters. +meteo_timeseries_T2: + data_type: DataFrame + path: c:\Developments\hydromt_delft3dfm\tests\data\local_data\rainfall_series.csv + driver: csv + driver_kwargs: + index_col: 0 + parse_dates: true + rename: + T2_mm/day: precip + meta: + unit: mm day-1 +pipes_defaults: + data_type: DataFrame + path: c:\Developments\hydromt_delft3dfm\hydromt_delft3dfm\data\branches\pipes_defaults.csv + driver: csv + meta: + notes: default pipe parameters. +rivers_defaults: + data_type: DataFrame + path: c:\Developments\hydromt_delft3dfm\hydromt_delft3dfm\data\branches\rivers_defaults.csv + driver: csv + meta: + notes: default river parameters. diff --git a/examples/dflowfm_piave/dflowfm/boundarycondition1d.bc b/examples/dflowfm_piave/dflowfm/boundarycondition1d.bc new file mode 100644 index 00000000..135fc0ee --- /dev/null +++ b/examples/dflowfm_piave/dflowfm/boundarycondition1d.bc @@ -0,0 +1,42 @@ +# written by HYDROLIB-core 0.5.2 + +[General] +fileVersion = 1.01 +fileType = boundConds + +[Forcing] +name = 1384118.718651_5855518.214933 +function = constant +offset = 0.0 +factor = 1.0 +quantity = waterlevelbnd +unit = m +-2.0 + +[Forcing] +name = 1393117.044157_5866704.071640 +function = constant +offset = 0.0 +factor = 1.0 +quantity = waterlevelbnd +unit = m +-2.0 + +[Forcing] +name = 1387829.368344_5866704.071640 +function = constant +offset = 0.0 +factor = 1.0 +quantity = waterlevelbnd +unit = m +-2.0 + +[Forcing] +name = 1391540.018037_5858077.577220 +function = constant +offset = 0.0 +factor = 1.0 +quantity = waterlevelbnd +unit = m +-2.0 + diff --git a/examples/dflowfm_piave/dflowfm/roughness_Manning_0.023.ini b/examples/dflowfm_piave/dflowfm/roughness_Manning_0.023.ini new file mode 100644 index 00000000..7e9eaa31 --- /dev/null +++ b/examples/dflowfm_piave/dflowfm/roughness_Manning_0.023.ini @@ -0,0 +1,11 @@ +# written by HYDROLIB-core 0.5.2 + +[General] +fileVersion = 3.01 # File version. Do not edit this. +fileType = roughness # File type. Should be 'roughness'. Do not edit this. + +[Global] +frictionId = Manning_0.023 # Name of the roughness variable. +frictionType = Manning # The global roughness type for this variable, which is used if no branch specific roughness definition is given. +frictionValue = 0.023 # The global default value for this roughness variable. + diff --git a/examples/dflowfm_piave/dflowfm/roughness_WhiteColeBrook_0.003.ini b/examples/dflowfm_piave/dflowfm/roughness_WhiteColeBrook_0.003.ini new file mode 100644 index 00000000..f5f445fb --- /dev/null +++ b/examples/dflowfm_piave/dflowfm/roughness_WhiteColeBrook_0.003.ini @@ -0,0 +1,11 @@ +# written by HYDROLIB-core 0.5.2 + +[General] +fileVersion = 3.01 # File version. Do not edit this. +fileType = roughness # File type. Should be 'roughness'. Do not edit this. + +[Global] +frictionId = WhiteColeBrook_0.003 # Name of the roughness variable. +frictionType = WhiteColebrook # The global roughness type for this variable, which is used if no branch specific roughness definition is given. +frictionValue = 0.003 # The global default value for this roughness variable. + diff --git a/examples/dflowfm_piave/hydromt_data.yml b/examples/dflowfm_piave/hydromt_data.yml new file mode 100644 index 00000000..92be36f5 --- /dev/null +++ b/examples/dflowfm_piave/hydromt_data.yml @@ -0,0 +1,78 @@ +grip_roads: + data_type: GeoDataFrame + path: C:\Users\li_xn\.hydromt_data\artifact_data\v0.0.8\grip_roads.gpkg + driver: vector + meta: + category: road + paper_doi: 10.1088/1748-9326/aabd42 + paper_ref: Meijer et al, 2018 + source_license: CC0-1.0 + source_url: https://www.globio.info/download-grip-dataset + source_version: v4 + crs: 4326 +manholes_defaults: + data_type: DataFrame + path: c:\Developments\hydromt_delft3dfm\hydromt_delft3dfm\data\storages\manholes_defaults.csv + driver: csv + meta: + notes: default manhole parameters. +merit_hydro: + data_type: RasterDataset + path: C:\Users\li_xn\.hydromt_data\artifact_data\v0.0.8\merit_hydro\{variable}.tif + driver: raster + meta: + category: topography + paper_doi: 10.1029/2019WR024873 + paper_ref: Yamazaki et al. (2019) + source_license: CC-BY-NC 4.0 or ODbL 1.0 + source_url: http://hydro.iis.u-tokyo.ac.jp/~yamadai/MERIT_Hydro + source_version: 1.0 + crs: 4326 +pipes_defaults: + data_type: DataFrame + path: c:\Developments\hydromt_delft3dfm\hydromt_delft3dfm\data\branches\pipes_defaults.csv + driver: csv + meta: + notes: default pipe parameters. +rivers_defaults: + data_type: DataFrame + path: c:\Developments\hydromt_delft3dfm\hydromt_delft3dfm\data\branches\rivers_defaults.csv + driver: csv + meta: + notes: default river parameters. +rivers_lin2019_v1: + data_type: GeoDataFrame + path: C:\Users\li_xn\.hydromt_data\artifact_data\v0.0.8\rivers_lin2019_v1.gpkg + driver: vector + meta: + category: hydrography + paper_doi: 10.5281/zenodo.3552776 + paper_ref: Lin et al. (2019) + source_license: CC-BY-NC 4.0 + source_url: https://zenodo.org/record/3552776#.YVbOrppByUk + source_version: 1 +vito: + data_type: RasterDataset + path: C:\Users\li_xn\.hydromt_data\artifact_data\v0.0.8\vito.tif + driver: raster + meta: + category: landuse & landcover + paper_doi: 10.5281/zenodo.3939038 + paper_ref: Buchhorn et al (2020) + source_url: https://land.copernicus.eu/global/products/lc + source_version: v2.0.2 + crs: 4326 +vito_mapping: + data_type: DataFrame + path: c:\Developments\hydromt_delft3dfm\hydromt_delft3dfm\data\landuse\vito_mapping.csv + driver: csv + driver_kwargs: + index_col: 0 + nodata: + landuse: 0 + roughness_manning: -999.0 + infiltcap: -999.0 + meta: + category: landuse + source_info: landuse parameters based on vito classification (https://land.copernicus.eu/global/products/lc) + source_version: 1.0 From 5e7720dbec573bb4368fdb1b581341b2030c5eee Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Tue, 24 Oct 2023 10:31:31 +0200 Subject: [PATCH 22/32] update changelog --- docs/changelog.rst | 3 ++- 1 file changed, 2 insertions(+), 1 deletion(-) diff --git a/docs/changelog.rst b/docs/changelog.rst index 00f2b6cb..15174c92 100644 --- a/docs/changelog.rst +++ b/docs/changelog.rst @@ -11,13 +11,14 @@ Unreleased Added ----- -- Setup 1D laterals at branches from points and polygons. (PR#81) +- Setup 1D laterals at branches from points and polygons. (PR #81) Changed ------- Fixed ----- +- Bugfixing of reading of frictions (global), crosssections and boundaries when update. (PR #81) v0.1.2 (20 October 2023) ======================== From 7307a83cd30ba2d58dc1257e0476c9814bd578ed Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Tue, 24 Oct 2023 11:00:27 +0200 Subject: [PATCH 23/32] recover fixes in read_maps from main --- hydromt_delft3dfm/dflowfm.py | 12 ++++++++---- 1 file changed, 8 insertions(+), 4 deletions(-) diff --git a/hydromt_delft3dfm/dflowfm.py b/hydromt_delft3dfm/dflowfm.py index d112b6f0..84259928 100644 --- a/hydromt_delft3dfm/dflowfm.py +++ b/hydromt_delft3dfm/dflowfm.py @@ -2886,12 +2886,16 @@ def read_maps(self) -> Dict[str, Union[xr.Dataset, xr.DataArray]]: # Read initial fields inifield_model = self.dfmmodel.geometry.inifieldfile # seperate 1d and 2d - inifield_model_1d = [ - i for i in inifield_model.initial if "1d" in i.datafiletype + # inifield_model_1d = [ + # i for i in inifield_model.initial if "1d" in i.locationtype + # ] # not supported yet + inifield_model_2dinitial = [ + i for i in inifield_model.initial if "2d" in i.locationtype ] - inifield_model_2d = [ - i for i in inifield_model.initial if "2d" in i.datafiletype + inifield_model_2dparameter = [ + i for i in inifield_model.parameter if "2d" in i.locationtype ] + inifield_model_2d = inifield_model_2dinitial + inifield_model_2dparameter if any(inifield_model_2d): # Loop over initial / parameter to read the geotif inilist = inifield_model_2d From d70a1a2e7dcef37bbb15aaee4651d995c475b02d Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Tue, 24 Oct 2023 11:07:23 +0200 Subject: [PATCH 24/32] fix code smell --- hydromt_delft3dfm/dflowfm.py | 15 +++++++-------- hydromt_delft3dfm/utils.py | 17 +++++++++-------- 2 files changed, 16 insertions(+), 16 deletions(-) diff --git a/hydromt_delft3dfm/dflowfm.py b/hydromt_delft3dfm/dflowfm.py index 84259928..1adeea30 100644 --- a/hydromt_delft3dfm/dflowfm.py +++ b/hydromt_delft3dfm/dflowfm.py @@ -1438,7 +1438,7 @@ def setup_1dboundary( ) # 2. read boundary from user data - gdf_bnds, da_bnd = self._read_forcing_geodataset( + _, da_bnd = self._read_forcing_geodataset( boundaries_geodataset_fn, boundary_type ) @@ -1604,7 +1604,7 @@ def setup_1dlateral_from_points( ) # 4. set laterals - self.set_forcing(da_out, name=f"lateral1d_points") + self.set_forcing(da_out, name="lateral1d_points") def setup_1dlateral_from_polygons( self, @@ -1640,7 +1640,7 @@ def setup_1dlateral_from_polygons( or for filling in missing data. By default 0 [m3/s]. """ - self.logger.info(f"Preparing 1D laterals for polygons.") + self.logger.info("Preparing 1D laterals for polygons.") # 1. read lateral geodataset gdf_laterals, da_lat = self._read_forcing_geodataset( @@ -1661,7 +1661,7 @@ def setup_1dlateral_from_polygons( ) # 3. set laterals - self.set_forcing(da_out, name=f"lateral1d_polygons") + self.set_forcing(da_out, name="lateral1d_polygons") def _setup_1dstructures( self, @@ -3237,10 +3237,9 @@ def read_mesh(self): # FIXME: crs info is not available in dfmmodel, so get it from region.geojson # Cannot use read_geoms yet because for some some geoms (crosssections, manholes) mesh needs to be read first... region_fn = join(self.root, "geoms", "region.geojson") - if not self._crs: - if isfile(region_fn): - crs = gpd.read_file(region_fn).crs - self._crs = crs + if (not self._crs) and isfile(region_fn): + crs = gpd.read_file(region_fn).crs + self._crs = crs crs = self.crs diff --git a/hydromt_delft3dfm/utils.py b/hydromt_delft3dfm/utils.py index b55cc334..d8f5892e 100644 --- a/hydromt_delft3dfm/utils.py +++ b/hydromt_delft3dfm/utils.py @@ -1,7 +1,7 @@ from enum import Enum from os.path import join from pathlib import Path -from typing import Dict, List, Tuple +from typing import Dict, List, Tuple, Union import geopandas as gpd import numpy as np @@ -739,7 +739,7 @@ def _remove_old_forcing_based_on_name(forcing): # write forcing file forcing_model = ForcingModel(forcing=bcdict) - forcing_fn = f"boundarycondition1d.bc" + forcing_fn = "boundarycondition1d.bc" forcing_model.save(join(savedir, forcing_fn), recurse=True) # add forcingfile to ext, note each node needs a forcingfile @@ -761,7 +761,6 @@ def _remove_old_forcing_based_on_name(forcing): def read_1dlateral( df: pd.DataFrame, quantity: str = "lateral_discharge", - nodes: gpd.GeoDataFrame = None, branches: gpd.GeoDataFrame = None, ) -> xr.DataArray: """ @@ -857,7 +856,7 @@ def read_1dlateral( coords=coords, attrs=bc, ) - da_out.name = f"lateral1d_polygons" + da_out.name = "lateral1d_polygons" else: # points if any(df.nodeid.values): @@ -885,12 +884,14 @@ def read_1dlateral( coords=coords, attrs=bc, ) - da_out.name = f"lateral1d_points" + da_out.name = "lateral1d_points" return da_out -def write_1dlateral(forcing: Dict, savedir: str = None, ext_fn: str = None) -> Tuple: +def write_1dlateral( + forcing: Dict, savedir: str = None, ext_fn: str = None +) -> Union[None, Tuple]: """ " write 1dlateral ext and bc files from forcing dict. @@ -983,7 +984,7 @@ def write_1dlateral(forcing: Dict, savedir: str = None, ext_fn: str = None) -> T # write forcing file forcing_model = ForcingModel(forcing=bcdict) - forcing_fn = f"lateral1d.bc" + forcing_fn = "lateral1d.bc" forcing_model.save(join(savedir, forcing_fn), recurse=True) # add forcingfile to ext, note forcing file is called discharge for lateral @@ -1319,7 +1320,7 @@ def write_meteo(forcing: Dict, savedir: str, ext_fn: str = None) -> list[dict]: def write_ext( - extdicts: Dict, + extdicts: List, savedir: Path, ext_fn: str = None, block_name: str = "boundary", From 7255f83c55ee3840773f44862588b15eaab96396 Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Fri, 24 Nov 2023 12:55:49 +0100 Subject: [PATCH 25/32] revision after review --- hydromt_delft3dfm/dflowfm.py | 225 ++---------------------- hydromt_delft3dfm/workflows/branches.py | 23 +++ 2 files changed, 40 insertions(+), 208 deletions(-) diff --git a/hydromt_delft3dfm/dflowfm.py b/hydromt_delft3dfm/dflowfm.py index 1adeea30..5fe95d79 100644 --- a/hydromt_delft3dfm/dflowfm.py +++ b/hydromt_delft3dfm/dflowfm.py @@ -1439,7 +1439,7 @@ def setup_1dboundary( # 2. read boundary from user data _, da_bnd = self._read_forcing_geodataset( - boundaries_geodataset_fn, boundary_type + boundaries_geodataset_fn, boundary_type, snap_offset ) # 3. Derive DataArray with boundary values at boundary locations in boundaries_branch_type @@ -1459,7 +1459,10 @@ def setup_1dboundary( ) # FIXME: this format cannot be read back due to lack of branch type info from model files def _read_forcing_geodataset( - self, forcing_geodataset_fn: Union[str, Path], forcing_name: str = "discharge" + self, + forcing_geodataset_fn: Union[str, Path], + forcing_name: str = "discharge", + region_buffer=0.0, ): """Read forcing geodataset.""" @@ -1472,11 +1475,11 @@ def _read_forcing_geodataset( da = self.data_catalog.get_geodataset( forcing_geodataset_fn, geom=self.region.buffer( - 1000 + region_buffer # buffer region ), # only select data within region of interest (large region for forcing) variables=[forcing_name], time_tuple=(tstart, tstop), - ).rename(forcing_name) + ) # error if time mismatch if np.logical_and( pd.to_datetime(da.time.values[0]) == pd.to_datetime(tstart), @@ -1487,7 +1490,7 @@ def _read_forcing_geodataset( self.logger.error( "forcing has different start and end time. Please check the forcing file. support yyyy-mm-dd HH:MM:SS. " ) - # reproject if needed and convert to location + # reproject if needed and convert to location #TODO change this after hydromt release >0.9.0 if da.vector.crs != self.crs: da = da.vector.to_crs(self.crs) # get geom @@ -1500,35 +1503,15 @@ def _read_forcing_geodataset( forcing_geodataset_fn, geom=self.region.buffer(self._network_snap_offset), ) + # reproject + if gdf.crs != self.crs: + gdf = gdf.to_crs(self.crs) da = None else: gdf = None da = None return gdf, da - def _snap_geom_to_branches_and_drop_nonsnapped( - self, branches: gpd.GeoDataFrame, geoms: gpd.GeoDataFrame, snap_offset=0.0 - ): - """Snaps geoms to branches and drop the ones that are not snapped. - Returns snapped geoms with branchid and chainage. - branches must have branchid. - """ - workflows.find_nearest_branch( - branches=branches, - geometries=geoms, - maxdist=snap_offset, - ) - geoms = geoms.rename( - columns={"branch_id": "branchid", "branch_offset": "chainage"} - ) - - # drop ones non snapped - _drop_geoms = geoms["chainage"].isna() - if any(_drop_geoms): - self.logger.debug(f"Unable to snap to branches: {geoms[_drop_geoms].index}") - - return geoms[~_drop_geoms] - def setup_1dlateral_from_points( self, laterals_geodataset_fn: str = None, @@ -1561,7 +1544,7 @@ def setup_1dlateral_from_points( ---------- laterals_geodataset_fn : str, Path Path or data source name for geospatial point location file. - * Required variables if geodataset is provided ['laterals_discharge'] + * Required variables if geodataset is provided ['lateral_discharge'] NOTE: Require equidistant time series lateral_value : float, optional Constant value to use for all laterals if ``laterals_geodataset_fn`` is a geodataframe, @@ -1580,11 +1563,11 @@ def setup_1dlateral_from_points( # 1. read lateral geodataset and snap to network gdf_laterals, da_lat = self._read_forcing_geodataset( - laterals_geodataset_fn, "lateral_discharge" + laterals_geodataset_fn, "lateral_discharge", snap_offset ) # snap laterlas to selected branches - gdf_laterals = self._snap_geom_to_branches_and_drop_nonsnapped( + gdf_laterals = workflows.snap_geom_to_branches_and_drop_nonsnapped( branches=network_by_branchtype.set_index("branchid"), geoms=gdf_laterals, snap_offset=snap_offset, @@ -1633,7 +1616,7 @@ def setup_1dlateral_from_polygons( ---------- laterals_geodataset_fn : str, Path Path or data source name for geospatial point location file. - * Required variables if geodataset is provided ['laterals_discharge'] + * Required variables if geodataset is provided ['lateral_discharge'] NOTE: Require equidistant time series lateral_value : float, optional Constant value to use for all laterals if ``laterals_geodataset_fn`` is a geodataframe, @@ -1663,180 +1646,6 @@ def setup_1dlateral_from_polygons( # 3. set laterals self.set_forcing(da_out, name="lateral1d_polygons") - def _setup_1dstructures( - self, - st_type: str, - st_fn: Union[str, Path, gpd.GeoDataFrame] = None, - defaults_fn: Union[str, Path, pd.DataFrame] = None, - filter: Optional[str] = None, - snap_offset: Optional[float] = None, - ): - """Setup 1D structures. - Include the universal weir (Not Implemented) , culvert and bridge (``str_type`` = 'bridge'), which can only be used in a single 1D channel. - - The structures are first read from ``st_fn`` (only locations within the region will be read), and if any missing, filled with information provided in ``defaults_fn``. - Read locations are then filtered for value specified in ``filter`` on the column ``st_type``. - They are then snapped to the existing network within a max distance defined in ``snap_offset`` and will be dropped if not snapped. - Finally, crossections are read and set up for the remaining structures. - - Parameters - ---------- - st_type: str, required - Name of structure type - - st_fn: str Path, optional - Path or data source name for structures, see data/data_sources.yml. - Note only the points that are within the region polygon will be used. - - * Optional variables: see the setup function for each ``st_type`` - - defaults_fn : str Path, optional - Path to a csv file containing all defaults values per "structure_type". - By default `hydrolib.hydromt_delft3dfm.data.bridges.bridges_defaults.csv` is used. This file describes a minimum rectangle bridge profile. - - * Allowed variables: see the setup function for each ``st_type`` - - filter: str, optional - Keyword in "structure_type" column of ``st_fn`` used to filter features. If None all features are used (default). - - snap_offset: float, optional - Snapping tolenrance to automatically snap bridges to network and add ['branchid', 'chainage'] attributes. - By default None. In this case, global variable "network_snap_offset" will be used. - - Returns - ------- - gdf_st: geopandas.GeoDataFrame - geodataframe of the structures and crossections - - - See Also - -------- - dflowfm.setup_bridges - dflowfm.setup_culverts - """ - if snap_offset is None: - snap_offset = self._network_snap_offset - self.logger.info( - f"Snap_offset is set to global network snap offset: {snap_offset}" - ) - - type_col = "structure_type" - id_col = "structure_id" - - branches = self.branches.set_index("branchid") - - # 1. Read data and filter within region - # If needed read the structures GeoDataFrame - if isinstance(st_fn, str) or isinstance(st_fn, Path): - gdf_st = self.data_catalog.get_geodataframe( - st_fn, geom=self.region, buffer=0, predicate="contains" - ) - else: - gdf_st = st_fn - # Filter features based on filter on type_col - if filter is not None and type_col in gdf_st.columns: - gdf_st = gdf_st[gdf_st[type_col].str.lower() == filter.lower()] - self.logger.info( - f"Set {filter} locations filtered from {st_fn} as {st_type} ." - ) - # Check if features in region - if len(gdf_st) == 0: - self.logger.warning(f"No 1D {type} locations found within domain") - return None - # reproject to model crs - gdf_st.to_crs(self.crs) - - # 2. Read defaults table - if isinstance(defaults_fn, pd.DataFrame): - defaults = defaults_fn - else: - if defaults_fn is None: - self.logger.warning( - f"defaults_fn ({defaults_fn}) does not exist. Fall back choice to defaults. " - ) - defaults_fn = Path(self._DATADIR).joinpath( - f"{st_type}s", f"{st_type}s_defaults.csv" - ) - defaults = self.data_catalog.get_dataframe(defaults_fn) - self.logger.info(f"{st_type} default settings read from {defaults_fn}.") - - # 3. Add defaults - # overwrite type and add id attributes if does not exist - gdf_st[type_col] = pd.Series( - data=np.repeat(st_type, len(gdf_st)), index=gdf_st.index, dtype=str - ) - if id_col not in gdf_st.columns: - data = [ - f"{st_type}_{i}" - for i in np.arange( - len(self.structures) + 1, len(self.structures) + len(gdf_st) + 1 - ) - ] # avoid duplicated ids being generated - gdf_st[id_col] = pd.Series(data, index=gdf_st.index, dtype=str) - # assign id - gdf_st.index = gdf_st[id_col] - gdf_st.index.name = id_col - # filter for allowed columns - allowed_columns = set(defaults.columns).intersection(gdf_st.columns) - allowed_columns.update({"geometry"}) - gdf_st = gpd.GeoDataFrame(gdf_st[list(allowed_columns)], crs=gdf_st.crs) - self.logger.info("Adding/Filling default attributes values") - gdf_st = workflows.update_data_columns_attributes_based_on_filter( - gdf_st, defaults, type_col, st_type - ) - - # 4. snap structures to branches - # setup branch_id - snap structures to branch (inplace of structures, will add branch_id and branch_offset columns) - workflows.find_nearest_branch( - branches=branches, geometries=gdf_st, maxdist=snap_offset - ) - # setup failed - drop based on branch_offset that are not snapped to branch - _old_ids = gdf_st.index.to_list() - gdf_st.dropna(axis=0, inplace=True, subset=["branch_offset"]) - _new_ids = gdf_st.index.to_list() - if len(_old_ids) != len(_new_ids): - logger.warning( - f"structure with id: {list(set(_old_ids) - set(_new_ids))} are dropped: unable to find closest branch. " - ) - if len(_new_ids) == 0: - self.logger.warning( - f"No 1D {type} locations found within the proximity of the network" - ) - return None - else: - # setup success, add branchid and chainage - gdf_st["structure_branchid"] = gdf_st["branch_id"] - gdf_st["structure_chainage"] = gdf_st["branch_offset"] - - # 5. add structure crossections - # add a dummy "shift" for crossection locations if missing (e.g. culverts), because structures only needs crossection definitions. - if "shift" not in gdf_st.columns: - gdf_st["shift"] = np.nan - # derive crosssections - gdf_st_crossections = workflows.set_point_crosssections( - branches, gdf_st, maxdist=snap_offset - ) - # remove crossection locations and any friction from the setup - gdf_st_crsdefs = gdf_st_crossections.drop( - columns=[ - c - for c in gdf_st_crossections.columns - if c.startswith("crsloc") or "friction" in c - ] - ) - # add to structures - gdf_st = gdf_st.merge( - gdf_st_crsdefs.drop(columns="geometry"), left_index=True, right_index=True - ) - - # 6. replace np.nan as None - gdf_st = gdf_st.replace(np.nan, None) - - # 7. remove index - gdf_st = gdf_st.reset_index() - - return gdf_st - def setup_bridges( self, bridges_fn: Optional[str] = None, @@ -1884,7 +1693,7 @@ def setup_bridges( See Also -------- - dflowfm._setup_1dstructures + workflows.prepare_1dstructures """ snap_offset = self._network_snap_offset if snap_offset is None else snap_offset _st_type = "bridge" @@ -2004,7 +1813,7 @@ def setup_culverts( See Also -------- - dflowfm._setup_1dstructures + workflows.prepare_1dstructures """ snap_offset = self._network_snap_offset if snap_offset is None else snap_offset _st_type = "culvert" diff --git a/hydromt_delft3dfm/workflows/branches.py b/hydromt_delft3dfm/workflows/branches.py index d0b96684..36758c01 100644 --- a/hydromt_delft3dfm/workflows/branches.py +++ b/hydromt_delft3dfm/workflows/branches.py @@ -27,6 +27,7 @@ "update_data_columns_attributes", "update_data_columns_attribute_from_query", "snap_newbranches_to_branches_at_snappednodes", + "snap_geom_to_branches_and_drop_nonsnapped", ] @@ -1233,3 +1234,25 @@ def _remove_branches_with_ring_geometries( logger.debug("Removing branches with ring geometries.") return branches + + +def snap_geom_to_branches_and_drop_nonsnapped( + branches: gpd.GeoDataFrame, geoms: gpd.GeoDataFrame, snap_offset=0.0 +): + """Snaps geoms to branches and drop the ones that are not snapped. + Returns snapped geoms with branchid and chainage. + branches must have branchid. + """ + find_nearest_branch( + branches=branches, + geometries=geoms, + maxdist=snap_offset, + ) + geoms = geoms.rename(columns={"branch_id": "branchid", "branch_offset": "chainage"}) + + # drop ones non snapped + _drop_geoms = geoms["chainage"].isna() + if any(_drop_geoms): + logger.debug(f"Unable to snap to branches: {geoms[_drop_geoms].index}") + + return geoms[~_drop_geoms] From 803d5fae8f3ab60541fd69c6d7ac2524f7cdf861 Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Fri, 24 Nov 2023 12:57:02 +0100 Subject: [PATCH 26/32] update doc --- docs/api.rst | 1 + 1 file changed, 1 insertion(+) diff --git a/docs/api.rst b/docs/api.rst index caeb708b..925e744e 100644 --- a/docs/api.rst +++ b/docs/api.rst @@ -174,6 +174,7 @@ Branches workflows.update_data_columns_attributes workflows.update_data_columns_attribute_from_query workflows.snap_newbranches_to_branches_at_snappednodes + workflows.snap_geom_to_branches_and_drop_nonsnapped Crosssections ------------- From 34f38dd601d733e76a57772d6f6a8d515fedc29f Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Fri, 24 Nov 2023 13:21:04 +0100 Subject: [PATCH 27/32] fix wrong commit --- examples/dflowfm_build_local.yml | 10 ++++++ hydromt_delft3dfm/dflowfm.py | 57 ++++++++++++++++++++++++++++++++ 2 files changed, 67 insertions(+) diff --git a/examples/dflowfm_build_local.yml b/examples/dflowfm_build_local.yml index 16429250..6e4279ba 100644 --- a/examples/dflowfm_build_local.yml +++ b/examples/dflowfm_build_local.yml @@ -47,6 +47,16 @@ setup_1dboundary: boundary_unit: m boundary_locs: both +setup_1dlateral_from_points: + laterals_geodataset_fn: 1D_laterals_timeseries + branch_type: river + snap_offset: 10 + lateral_value: 0 + +setup_1dlateral_from_polygons: + laterals_geodataset_fn: 1D_laterals_polygons_timeseries + lateral_value: 0 + setup_mesh2d: region: geom: "local_data/1D_extent.geojson" diff --git a/hydromt_delft3dfm/dflowfm.py b/hydromt_delft3dfm/dflowfm.py index 67a0a627..aacf13d3 100644 --- a/hydromt_delft3dfm/dflowfm.py +++ b/hydromt_delft3dfm/dflowfm.py @@ -1713,6 +1713,63 @@ def setup_1dlateral_from_points( logger=self.logger, ) + # 3. set laterals + self.set_forcing(da_out, name="lateral1d_points") + + def setup_1dlateral_from_polygons( + self, + laterals_geodataset_fn: str = None, + lateral_value: float = -2.5, + ): + """ + Prepares the 1D lateral discharge from geodataset of polygons. + E.g. '1' m3/s for all lateral locations. + + Use ``laterals_geodataset_fn`` to set the lateral values from a geodatasets + of polygons. + Support also geodataframe of polygons in combination of `lateral_value`. + + The discharge can either be a constant using ``lateral_value`` (default) or + a timeseries read from ``laterals_geodataset_fn``. + If the timeseries has missing values, the constant ``lateral_value`` will be used. + + The timeseries are clipped to the model time based on the model config + tstart and tstop entries. + + Adds/Updates model layers: + * ** lateral1d_polygons** forcing: 1D laterals DataArray with polygon coordinates. + + Parameters + ---------- + laterals_geodataset_fn : str, Path + Path or data source name for geospatial point location file. + * Required variables if geodataset is provided ['lateral_discharge'] + NOTE: Require equidistant time series + lateral_value : float, optional + Constant value to use for all laterals if ``laterals_geodataset_fn`` is a geodataframe, + or for filling in missing data. + By default 0 [m3/s]. + """ + self.logger.info("Preparing 1D laterals for polygons.") + + # 1. read lateral geodataset + gdf_laterals, da_lat = self._read_forcing_geodataset( + laterals_geodataset_fn, "lateral_discharge" + ) + + if len(gdf_laterals) == 0: + return None + + # 2. Compute lateral dataarray + da_out = workflows.compute_forcing_values_polygon( + gdf=gdf_laterals, + da=da_lat, + forcing_value=lateral_value, + forcing_type="lateral_discharge", + forcing_unit="m3/s", + logger=self.logger, + ) + # 3. set laterals self.set_forcing(da_out, name="lateral1d_polygons") From 4341acb4ca94f328cf925408cbc5479275b8a1f1 Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Fri, 24 Nov 2023 13:34:14 +0100 Subject: [PATCH 28/32] fix precommit --- hydromt_delft3dfm/dflowfm.py | 35 ++++++++++++----------- hydromt_delft3dfm/mesh_utils.py | 2 +- hydromt_delft3dfm/utils.py | 13 +++++---- hydromt_delft3dfm/workflows/boundaries.py | 30 +++++++++---------- hydromt_delft3dfm/workflows/branches.py | 6 ++-- 5 files changed, 46 insertions(+), 40 deletions(-) diff --git a/hydromt_delft3dfm/dflowfm.py b/hydromt_delft3dfm/dflowfm.py index aacf13d3..1a4160db 100644 --- a/hydromt_delft3dfm/dflowfm.py +++ b/hydromt_delft3dfm/dflowfm.py @@ -1592,7 +1592,6 @@ def _read_forcing_geodataset( region_buffer=0.0, ): """Read forcing geodataset.""" - refdate, tstart, tstop = self.get_model_time() # time slice if ( @@ -1601,9 +1600,7 @@ def _read_forcing_geodataset( ): da = self.data_catalog.get_geodataset( forcing_geodataset_fn, - geom=self.region.buffer( - region_buffer # buffer region - ), # only select data within region of interest (large region for forcing) + geom=self.region.buffer(region_buffer), # buffer region variables=[forcing_name], time_tuple=(tstart, tstop), ) @@ -1615,11 +1612,13 @@ def _read_forcing_geodataset( pass else: self.logger.error( - "forcing has different start and end time. Please check the forcing file. support yyyy-mm-dd HH:MM:SS. " + "Forcing has different start and end time." + + " Please check the forcing file. Support yyyy-mm-dd HH:MM:SS. " ) - # reproject if needed and convert to location #TODO change this after hydromt release >0.9.0 + # reproject if needed and convert to location if da.vector.crs != self.crs: da = da.vector.to_crs(self.crs) + # TODO update after hydromt release >0.9.0 # get geom gdf = da.vector.to_gdf(reducer=np.mean) elif ( @@ -1647,7 +1646,8 @@ def setup_1dlateral_from_points( branch_type: str = "river", ): """ - Prepares the 1D lateral discharge from geodataset of point geometries. + Prepare the 1D lateral discharge from geodataset of point geometries. + E.g. '1' m3/s for all lateral locations. Use ``laterals_geodataset_fn`` to set the lateral values from a geodataset @@ -1659,13 +1659,13 @@ def setup_1dlateral_from_points( The discharge can either be a constant using ``lateral_value`` (default) or a timeseries read from ``laterals_geodataset_fn``. - If the timeseries has missing values, the constant ``lateral_value`` will be used. + If the timeseries has missing values, constant ``lateral_value`` will be used. The timeseries are clipped to the model time based on the model config tstart and tstop entries. Adds/Updates model layers: - * ** lateral1d_points** forcing: 1D laterals DataArray with points coordinates. + ** lateral1d_points** forcing: DataArray with points coordinates. Parameters ---------- @@ -1674,11 +1674,11 @@ def setup_1dlateral_from_points( * Required variables if geodataset is provided ['lateral_discharge'] NOTE: Require equidistant time series lateral_value : float, optional - Constant value to use for all laterals if ``laterals_geodataset_fn`` is a geodataframe, + Constant value, used if ``laterals_geodataset_fn`` is a geodataframe, or for filling in missing data. By default 0 [m3/s]. snap_offset : float, optional - Snapping tolerance to automatically applying boundaries at the correct network nodes. + Snapping tolerance to snap boundaries to the correct network nodes. By default 0.1, a small snapping is applied to avoid precision errors. branch_type: str, optional Type of branch to apply laterals on. One of ["river", "pipe"]. @@ -1722,7 +1722,8 @@ def setup_1dlateral_from_polygons( lateral_value: float = -2.5, ): """ - Prepares the 1D lateral discharge from geodataset of polygons. + Prepare the 1D lateral discharge from geodataset of polygons. + E.g. '1' m3/s for all lateral locations. Use ``laterals_geodataset_fn`` to set the lateral values from a geodatasets @@ -1731,13 +1732,13 @@ def setup_1dlateral_from_polygons( The discharge can either be a constant using ``lateral_value`` (default) or a timeseries read from ``laterals_geodataset_fn``. - If the timeseries has missing values, the constant ``lateral_value`` will be used. + If the timeseries has missing values, constant ``lateral_value`` will be used. The timeseries are clipped to the model time based on the model config tstart and tstop entries. Adds/Updates model layers: - * ** lateral1d_polygons** forcing: 1D laterals DataArray with polygon coordinates. + * ** lateral1d_polygons** forcing: DataArray with polygon coordinates. Parameters ---------- @@ -1746,7 +1747,7 @@ def setup_1dlateral_from_polygons( * Required variables if geodataset is provided ['lateral_discharge'] NOTE: Require equidistant time series lateral_value : float, optional - Constant value to use for all laterals if ``laterals_geodataset_fn`` is a geodataframe, + Constant value, used if ``laterals_geodataset_fn`` is a geodataframe, or for filling in missing data. By default 0 [m3/s]. """ @@ -3198,7 +3199,8 @@ def write_geoms(self, write_mesh_gdf=True) -> None: for name, gdf in self.mesh_gdf.items(): self.set_geoms(gdf, name) - # Write geojson equivalent of all objects. Note that these files are not directly used when updating the model + # Write geojson equivalent of all objects. + # NOTE these files are not used for model update. # convert any list in geoms to strings def convert_lists_to_strings(df): for column_name in df.columns: @@ -3595,6 +3597,7 @@ def closedsystem(self): @property def boundaries(self): + """1D boundary locations.""" if "boundaries" not in self.geoms: self.set_geoms( workflows.get_boundaries_with_nodeid( diff --git a/hydromt_delft3dfm/mesh_utils.py b/hydromt_delft3dfm/mesh_utils.py index 3c7935cf..af56b410 100644 --- a/hydromt_delft3dfm/mesh_utils.py +++ b/hydromt_delft3dfm/mesh_utils.py @@ -4,11 +4,11 @@ from typing import Tuple import geopandas as gpd -from shapely.geometry import LineString import xarray as xr import xugrid as xu from hydrolib.core.dflowfm import Network from pyproj import CRS +from shapely.geometry import LineString logger = logging.getLogger(__name__) diff --git a/hydromt_delft3dfm/utils.py b/hydromt_delft3dfm/utils.py index 41a745c6..841df3aa 100644 --- a/hydromt_delft3dfm/utils.py +++ b/hydromt_delft3dfm/utils.py @@ -18,8 +18,8 @@ FMModel, ForcingModel, FrictionModel, - Meteo, Lateral, + Meteo, PolyFile, StorageNodeModel, StructureModel, @@ -795,7 +795,9 @@ def read_1dlateral( branches: gpd.GeoDataFrame = None, ) -> xr.DataArray: """ - Read for a specific quantity the corresponding external and forcing files and parse to xarray + Read a 1D lateral from external and forcing files. + + Parsed to xarray. Parameters ---------- @@ -859,7 +861,8 @@ def read_1dlateral( # Else not implemented yet else: raise NotImplementedError( - f"ForcingFile with several function for a single variable not implemented yet. Skipping reading forcing for variable {quantity}." + "ForcingFile with several function for a single variable not implemented." + + f"Skipping reading forcing for variable {quantity}." ) # Get lateral locations and update dimentions and coordinates @@ -923,8 +926,8 @@ def read_1dlateral( def write_1dlateral( forcing: Dict, savedir: str = None, ext_fn: str = None ) -> Union[None, Tuple]: - """ " - write 1dlateral ext and bc files from forcing dict. + """ + Write 1dlateral ext and bc files from forcing dict. Parameters ---------- diff --git a/hydromt_delft3dfm/workflows/boundaries.py b/hydromt_delft3dfm/workflows/boundaries.py index 3d685d37..177ba7f6 100644 --- a/hydromt_delft3dfm/workflows/boundaries.py +++ b/hydromt_delft3dfm/workflows/boundaries.py @@ -8,7 +8,7 @@ import numpy as np import pandas as pd import xarray as xr -from shapely.geometry import Point, Polygon +from shapely.geometry import Point from hydromt_delft3dfm import graph_utils @@ -267,9 +267,8 @@ def compute_boundary_values( # snap user boundary to potential boundary locations to get nodeid gdf_bnd = da_bnd.vector.to_gdf() - gdf_bnd.crs = ( - boundaries.crs - ) # FIXME temp fix for hydromt reprojection issue #613 + gdf_bnd.crs = boundaries.crs + # TODO remove after hydromt release>0.9.0 gdf_bnd = hydromt.gis_utils.nearest_merge( gdf_bnd, boundaries, @@ -628,7 +627,7 @@ def compute_meteo_forcings( def _standardize_forcing_timeindexes(da): - """Standardize timeindexes frequency based on forcing DataArray""" + """Standardize timeindexes frequency based on forcing DataArray.""" _TIMESTR = {"D": "days", "H": "hours", "T": "minutes", "S": "seconds"} dt = pd.to_timedelta((da.time[1].values - da.time[0].values)) freq = dt.resolution_string @@ -636,7 +635,7 @@ def _standardize_forcing_timeindexes(da): if freq == "D": logger.warning( "time unit days is not supported by the current GUI version: 2022.04" - ) # converting to hours as temporary solution # FIXME: day is converted to hours temporarily + ) # TODO: remove temporay pin on GUI version multiplier = 24 if len(pd.date_range(da.time[0].values, da.time[-1].values, freq=dt)) != len( da.time @@ -718,7 +717,7 @@ def compute_forcing_values_points( timeInterpolation="Linear", quantity=f"{forcing_type}", units=f"{forcing_unit}", - time_unit=f"{freq_name} since {pd.to_datetime(da.time[0].values)}", # support only yyyy-mm-dd HH:MM:SS + time_unit=f"{freq_name} since {pd.to_datetime(da.time[0].values)}", ), ) # fill in na using default @@ -730,9 +729,7 @@ def compute_forcing_values_points( # add name da_out.name = f"{forcing_type}" else: - logger.info( - f"Using constant value {forcing_value} {forcing_unit} for all {forcing_type} forcings." - ) + logger.info(f"Use constant {forcing_value} {forcing_unit} for {forcing_type}.") # instantiate xr.DataArray for bnd data with forcing_type directly da_out = xr.DataArray( data=np.full((len(gdf.index)), forcing_value, dtype=np.float32), @@ -757,8 +754,11 @@ def compute_forcing_values_points( def get_geometry_coords_for_polygons(gdf): - """Gets xarray DataArray coordinates that describes polygon geometries. - Inlcudes numcoordinates, xcoordinates and ycoordinates""" + """ + Get xarray DataArray coordinates that describes polygon geometries. + + Inlcude numcoordinates, xcoordinates and ycoordinates. + """ if gdf.geometry.type.iloc[0] == "Polygon": # Get the maximum number of coordinates for any polygon max_coords = gdf["geometry"].apply(lambda x: len(x.exterior.coords[:])).max() @@ -861,7 +861,7 @@ def compute_forcing_values_polygon( timeInterpolation="Linear", quantity=f"{forcing_type}", units=f"{forcing_unit}", - time_unit=f"{freq_name} since {pd.to_datetime(da.time[0].values)}", # support only yyyy-mm-dd HH:MM:SS + time_unit=f"{freq_name} since {pd.to_datetime(da.time[0].values)}", ), ) # fill in na using default @@ -873,9 +873,7 @@ def compute_forcing_values_polygon( # add name da_out.name = f"{forcing_type}" else: - logger.info( - f"Using constant value {forcing_value} {forcing_unit} for all {forcing_type} forcings." - ) + logger.info(f"Use constant {forcing_value} {forcing_unit} for {forcing_type}.") # instantiate xr.DataArray for forcing data with forcing_type directly coords_dict = get_geometry_coords_for_polygons(gdf) data_3d = np.full( diff --git a/hydromt_delft3dfm/workflows/branches.py b/hydromt_delft3dfm/workflows/branches.py index 36758c01..22a3e364 100644 --- a/hydromt_delft3dfm/workflows/branches.py +++ b/hydromt_delft3dfm/workflows/branches.py @@ -1239,9 +1239,11 @@ def _remove_branches_with_ring_geometries( def snap_geom_to_branches_and_drop_nonsnapped( branches: gpd.GeoDataFrame, geoms: gpd.GeoDataFrame, snap_offset=0.0 ): - """Snaps geoms to branches and drop the ones that are not snapped. + """ + Snap geoms to branches and drop the ones that are not snapped. + Returns snapped geoms with branchid and chainage. - branches must have branchid. + Branches must have branchid. """ find_nearest_branch( branches=branches, From 8647f1b6a3900267c92d5a512891ec4d1f49374f Mon Sep 17 00:00:00 2001 From: hboisgon Date: Tue, 28 Nov 2023 12:06:31 +0800 Subject: [PATCH 29/32] remove code duplicates --- docs/api.rst | 1 - hydromt_delft3dfm/utils.py | 257 +++++++++------------- hydromt_delft3dfm/workflows/boundaries.py | 71 +----- 3 files changed, 110 insertions(+), 219 deletions(-) diff --git a/docs/api.rst b/docs/api.rst index 76ea5cd8..d6f660fa 100644 --- a/docs/api.rst +++ b/docs/api.rst @@ -150,7 +150,6 @@ Boundaries :toctree: _generated workflows.get_boundaries_with_nodeid - workflows.generate_boundaries_from_branches workflows.select_boundary_type workflows.validate_boundaries workflows.compute_boundary_values diff --git a/hydromt_delft3dfm/utils.py b/hydromt_delft3dfm/utils.py index 841df3aa..bbad2b77 100644 --- a/hydromt_delft3dfm/utils.py +++ b/hydromt_delft3dfm/utils.py @@ -594,51 +594,60 @@ def write_manholes(gdf: gpd.GeoDataFrame, savedir: str) -> str: return storage_fn -def read_1dboundary( - df: pd.DataFrame, quantity: str, nodes: gpd.GeoDataFrame -) -> xr.DataArray: +def _read_forcingfile( + df_forcing: pd.DataFrame, + index_values: Union[np.ndarray, str], + quantity: str, + allow_constant: bool = True, + add_interpolation: bool = True, + add_factor_offset: bool = True, +) -> Tuple[np.ndarray, List, Dict, Dict]: """ - Read for a specific quantity the external and forcing files and parse to xarray. - - # TODO: support external forcing for 2D. + Read forcing dataframe and parse to xarray properties. Parameters ---------- - df: pd.DataFrame - External Model DataFrame filtered for quantity. + df_forcing: pd.DataFrame + Dataframe with forcing data. + index_values: np.ndarray or str + Index values of the forcing data. quantity: str Name of quantity (eg 'waterlevel'). - nodes: gpd.GeoDataFrame - Nodes locations of the boundary in df. + allow_constant: bool, optional + If True, allow constant forcing. + add_interpolation: bool, optional + If True, add timeinterpolation attribute. + add_factor_offset: bool, optional + If True, add factor and offset attributes. Returns ------- - da_out: xr.DataArray - External and focing values combined into a DataArray for variable quantity. + data: np.ndarray + Data of the forcing. + dims: list + Dimensions of the forcing. + coords: dict + Coordinates of the forcing. + bc: dict + Attributes of the forcing. """ - # Initialise dataarray attributes + # Initialise dataarray attributes bc bc = {"quantity": quantity} - nodeids = df.nodeid.values - nodeids = nodeids[nodeids != "nan"] - # Assume one forcing file (hydromt writer) and read - forcing = df.forcingfile.iloc[0] - df_forcing = pd.DataFrame([f.__dict__ for f in forcing.forcing]) - # Filter for the current nodes, remove nans - df_forcing = df_forcing[np.isin(df_forcing.name, nodeids)] - # Get data + # Get data from forcing df # Check if all constant - if np.all(df_forcing.function == "constant"): + if np.all(df_forcing.function == "constant") and allow_constant: # Prepare data data = np.array([v[0][0] for v in df_forcing.datablock]) data = data + df_forcing.offset.values * df_forcing.factor.values # Prepare dataarray properties dims = ["index"] - coords = dict(index=nodeids) + coords = dict(index=index_values) bc["function"] = "constant" bc["units"] = df_forcing.quantityunitpair.iloc[0][0].unit - bc["factor"] = 1 - bc["offset"] = 0 + if add_factor_offset: + bc["factor"] = 1 + bc["offset"] = 0 # Check if all timeseries elif np.all(df_forcing.function == "timeseries"): # Prepare data @@ -654,12 +663,15 @@ def read_1dboundary( times = np.array([n[0] for n in df_forcing.datablock.iloc[0]]) # Prepare dataarray properties dims = ["index", "time"] - coords = dict(index=nodeids, time=times) + coords = dict(index=index_values, time=times) bc["function"] = "timeseries" + if add_interpolation: + bc["timeinterpolation"] = df_forcing.timeinterpolation.iloc[0] bc["units"] = df_forcing.quantityunitpair.iloc[0][1].unit bc["time_unit"] = df_forcing.quantityunitpair.iloc[0][0].unit - bc["factor"] = 1 - bc["offset"] = 0 + if add_factor_offset: + bc["factor"] = 1 + bc["offset"] = 0 # Else not implemented yet else: raise NotImplementedError( @@ -667,6 +679,48 @@ def read_1dboundary( f"Skipping reading forcing for variable {quantity}." ) + return data, dims, coords, bc + + +def read_1dboundary( + df: pd.DataFrame, quantity: str, nodes: gpd.GeoDataFrame +) -> xr.DataArray: + """ + Read for a specific quantity the external and forcing files and parse to xarray. + + # TODO: support external forcing for 2D. + + Parameters + ---------- + df: pd.DataFrame + External Model DataFrame filtered for quantity. + quantity: str + Name of quantity (eg 'waterlevel'). + nodes: gpd.GeoDataFrame + Nodes locations of the boundary in df. + + Returns + ------- + da_out: xr.DataArray + External and focing values combined into a DataArray for variable quantity. + """ + nodeids = df.nodeid.values + nodeids = nodeids[nodeids != "nan"] + # Assume one forcing file (hydromt writer) and read + forcing = df.forcingfile.iloc[0] + df_forcing = pd.DataFrame([f.__dict__ for f in forcing.forcing]) + # Filter for the current nodes, remove nans + df_forcing = df_forcing[np.isin(df_forcing.name, nodeids)] + + data, dims, coords, bc = _read_forcingfile( + df_forcing, + index_coords=nodeids, + quantity=quantity, + allow_constant=True, + add_interpolation=False, + add_factor_offset=True, + ) + # Get nodeid coordinates node_geoms = nodes.set_index("nodeid").reindex(nodeids) # # get rid of missing geometries @@ -816,54 +870,18 @@ def read_1dlateral( da_out: xr.DataArray External and focing values combined into a DataArray for variable quantity. """ - # Initialise dataarray attributes - bc = {"quantity": quantity} - # Assume one discharge (lateral specific) file (hydromt writer) and read forcing = df.discharge.iloc[0] df_forcing = pd.DataFrame([f.__dict__ for f in forcing.forcing]) - # Get data - # Check if all constant - if np.all(df_forcing.function == "constant"): - # Prepare data - data = np.array([v[0][0] for v in df_forcing.datablock]) - data = data + df_forcing.offset.values * df_forcing.factor.values - # Prepare dataarray properties - dims = ["index"] - coords = dict(index=df_forcing.name) - bc["function"] = "constant" - bc["units"] = df_forcing.quantityunitpair.iloc[0][0].unit - bc["factor"] = 1 - bc["offset"] = 0 - # Check if all timeseries - elif np.all(df_forcing.function == "timeseries"): - # Prepare data - data = list() - for i in np.arange(len(df_forcing.datablock)): - v = df_forcing.datablock.iloc[i] - offset = df_forcing.offset.iloc[i] - factor = df_forcing.factor.iloc[i] - databl = [n[1] * factor + offset for n in v] - data.append(databl) - data = np.array(data) - # Assume unique times - times = np.array([n[0] for n in df_forcing.datablock.iloc[0]]) - # Prepare dataarray properties - dims = ["index", "time"] - coords = dict(index=df_forcing.name, time=times) - bc["function"] = "timeseries" - bc["timeinterpolation"] = df_forcing.timeinterpolation.iloc[0] - bc["units"] = df_forcing.quantityunitpair.iloc[0][1].unit - bc["time_unit"] = df_forcing.quantityunitpair.iloc[0][0].unit - bc["factor"] = 1 - bc["offset"] = 0 - # Else not implemented yet - else: - raise NotImplementedError( - "ForcingFile with several function for a single variable not implemented." - + f"Skipping reading forcing for variable {quantity}." - ) + data, dims, coords, bc = _read_forcingfile( + df_forcing, + index_coords=df_forcing.name, + quantity=quantity, + allow_constant=True, + add_interpolation=True, + add_factor_offset=True, + ) # Get lateral locations and update dimentions and coordinates if any(df.numcoordinates.values): @@ -1053,46 +1071,26 @@ def read_2dboundary(df: pd.DataFrame, workdir: Path = Path.cwd()) -> xr.DataArra External and forcing values combined into a DataArray with name starts with "boundary2d". """ - # Initialise dataarray attributes - bc = {"quantity": df.quantity} # location file # assume one location file has only one location (hydromt writer) and read locationfile = PolyFile(workdir.joinpath(df.locationfile.filepath)) boundary_name = locationfile.objects[0].metadata.name boundary_points = pd.DataFrame([f.__dict__ for f in locationfile.objects[0].points]) - bc["locationfile"] = df.locationfile.filepath.name + # Assume one forcing file (hydromt writer) and read forcing = df.forcingfile df_forcing = pd.DataFrame([f.__dict__ for f in forcing.forcing]) - # Get data - # Check if all constant, Assume only timeseries exist (hydromt writer) and read - if np.all(df_forcing.function == "timeseries"): - # Prepare data - data = list() - for i in np.arange(len(df_forcing.datablock)): - v = df_forcing.datablock.iloc[i] - offset = df_forcing.offset.iloc[i] - factor = df_forcing.factor.iloc[i] - databl = [n[1] * factor + offset for n in v] - data.append(databl) - data = np.array(data) - # Assume unique times - times = np.array([n[0] for n in df_forcing.datablock.iloc[0]]) - # prepare index - indexes = df_forcing.name.values - # Prepare dataarray properties - dims = ["index", "time"] - coords = dict(index=indexes, time=times) - bc["function"] = "timeseries" - bc["units"] = df_forcing.quantityunitpair.iloc[0][1].unit - bc["time_unit"] = df_forcing.quantityunitpair.iloc[0][0].unit - # Else not implemented yet - else: - raise NotImplementedError( - "ForcingFile with several function for a single variable not implemented." - "Skipping reading forcing." - ) + data, dims, coords, bc = _read_forcingfile( + df_forcing, + index_coords=df_forcing.name.values, + quantity=df.quantity, + allow_constant=False, + add_interpolation=False, + add_factor_offset=False, + ) + + bc["locationfile"] = df.locationfile.filepath.name # Get coordinates coords["x"] = ("index", boundary_points.x.values) @@ -1219,57 +1217,20 @@ def read_meteo(df: pd.DataFrame, quantity: str) -> xr.DataArray: da_out: xr.DataArray External and focing values combined into a DataArray for variable quantity. """ - # Initialise dataarray attributes - bc = {"quantity": quantity} - # Assume one forcing file (hydromt writer) and read forcing = df.forcingfile.iloc[0] df_forcing = pd.DataFrame([f.__dict__ for f in forcing.forcing]) # Filter for the current nodes df_forcing = df_forcing[np.isin(df_forcing.name, "global")] - # Get data - # Check if all constant - if np.all(df_forcing.function == "constant"): - # Prepare data - data = np.array([v[0][0] for v in df_forcing.datablock]) - data = data + df_forcing.offset.values * df_forcing.factor.values - # Prepare dataarray properties - dims = ["index"] - coords = dict(index="global") - bc["function"] = "constant" - bc["units"] = df_forcing.quantityunitpair.iloc[0][0].unit - bc["factor"] = 1 - bc["offset"] = 0 - # Check if all timeseries - elif np.all(df_forcing.function == "timeseries"): - # Prepare data - data = list() - for i in np.arange(len(df_forcing.datablock)): - v = df_forcing.datablock.iloc[i] - offset = df_forcing.offset.iloc[i] - factor = df_forcing.factor.iloc[i] - databl = [n[1] * factor + offset for n in v] - data.append(databl) - data = np.array(data) - # Assume unique times - times = np.array([n[0] for n in df_forcing.datablock.iloc[0]]) - # Prepare dataarray properties - dims = ["index", "time"] - coords = dict(index=["global"], time=times) - bc["function"] = "timeseries" - bc["timeinterpolation"] = df_forcing.timeinterpolation.iloc[0] - bc["units"] = df_forcing.quantityunitpair.iloc[0][1].unit - bc["time_unit"] = df_forcing.quantityunitpair.iloc[0][0].unit - bc["factor"] = df_forcing.factor.iloc[0] - bc["offset"] = df_forcing.offset.iloc[0] - # Else not implemented yet - else: - raise NotImplementedError( - "ForcingFile with several function for a single variable not implemented." - f"Skipping reading forcing for variable {quantity}." - ) - + data, dims, coords, bc = _read_forcingfile( + df_forcing, + index_coords="global", + quantity=quantity, + allow_constant=True, + add_interpolation=True, + add_factor_offset=True, + ) # Do not apply to "global" meteo # coords["x"] # coords["y"] diff --git a/hydromt_delft3dfm/workflows/boundaries.py b/hydromt_delft3dfm/workflows/boundaries.py index 177ba7f6..0cc5a5d7 100644 --- a/hydromt_delft3dfm/workflows/boundaries.py +++ b/hydromt_delft3dfm/workflows/boundaries.py @@ -8,7 +8,6 @@ import numpy as np import pandas as pd import xarray as xr -from shapely.geometry import Point from hydromt_delft3dfm import graph_utils @@ -17,7 +16,6 @@ __all__ = [ "get_boundaries_with_nodeid", - "generate_boundaries_from_branches", "select_boundary_type", "validate_boundaries", "compute_boundary_values", @@ -44,7 +42,7 @@ def get_boundaries_with_nodeid( A GeoDataFrame with boundary locations and their associated node IDs. """ # generate all possible and allowed boundary locations - _boundaries = generate_boundaries_from_branches(branches, where="both") + _boundaries = graph_utils.get_endnodes_from_lines(branches, where="both") boundaries = hydromt.gis_utils.nearest_merge( _boundaries, network1d_nodes, max_dist=0.1, overwrite=False @@ -52,73 +50,6 @@ def get_boundaries_with_nodeid( return boundaries -def generate_boundaries_from_branches( - branches: gpd.GeoDataFrame, where: str = "both" -) -> gpd.GeoDataFrame: - """Get the possible boundary locations from the branches with id. - - Parameters - ---------- - where : {'both', 'upstream', 'downstream'} - Where at the branches should the boundaries be derived. - An upstream end node is defined as a node which has 0 incoming - branches and 1 outgoing branch. - A downstream end node is defined as a node which has 1 incoming - branch and 0 outgoing branches. - - Returns - ------- - gpd.GeoDataFrame - A data frame containing all the upstream and downstream - end nodes of the branches - """ - # convert branches to graph - G = graph_utils.gpd_to_digraph(branches) - - # get boundary locations at where - if where == "downstream": - endnodes = { - dn: {**d, **{"where": "downstream"}} - for up, dn, d in G.edges(data=True) - if G.out_degree[dn] == 0 and G.degree[dn] == 1 - } - elif where == "upstream": - endnodes = { - up: {**d, **{"where": "upstream"}} - for up, dn, d in G.edges(data=True) - if G.in_degree[up] == 0 and G.degree[up] == 1 - } - elif where == "both": - endnodes = { - dn: {**d, **{"where": "downstream"}} - for up, dn, d in G.edges(data=True) - if G.out_degree[dn] == 0 and G.degree[dn] == 1 - } - endnodes.update( - { - up: {**d, **{"where": "upstream"}} - for up, dn, d in G.edges(data=True) - if G.in_degree[up] == 0 and G.degree[up] == 1 - } - ) - else: - pass - - if len(endnodes) == 0: - logger.error(f"cannot generate boundaries for given condition {where}") - - endnodes_pd = ( - pd.DataFrame().from_dict(endnodes, orient="index").drop(columns=["geometry"]) - ) - endnodes_gpd = gpd.GeoDataFrame( - data=endnodes_pd, - geometry=[Point(endnode) for endnode in endnodes], - crs=branches.crs, - ) - endnodes_gpd.reset_index(inplace=True) - return endnodes_gpd - - def select_boundary_type( boundaries: gpd.GeoDataFrame, branch_type: str, From b16f462d496185b1a6c1ba11173fce92d7c457d3 Mon Sep 17 00:00:00 2001 From: hboisgon Date: Tue, 28 Nov 2023 12:10:34 +0800 Subject: [PATCH 30/32] bugfix --- hydromt_delft3dfm/utils.py | 8 ++++---- 1 file changed, 4 insertions(+), 4 deletions(-) diff --git a/hydromt_delft3dfm/utils.py b/hydromt_delft3dfm/utils.py index bbad2b77..5a1bae48 100644 --- a/hydromt_delft3dfm/utils.py +++ b/hydromt_delft3dfm/utils.py @@ -714,7 +714,7 @@ def read_1dboundary( data, dims, coords, bc = _read_forcingfile( df_forcing, - index_coords=nodeids, + index_values=nodeids, quantity=quantity, allow_constant=True, add_interpolation=False, @@ -876,7 +876,7 @@ def read_1dlateral( data, dims, coords, bc = _read_forcingfile( df_forcing, - index_coords=df_forcing.name, + index_values=df_forcing.name, quantity=quantity, allow_constant=True, add_interpolation=True, @@ -1083,7 +1083,7 @@ def read_2dboundary(df: pd.DataFrame, workdir: Path = Path.cwd()) -> xr.DataArra data, dims, coords, bc = _read_forcingfile( df_forcing, - index_coords=df_forcing.name.values, + index_values=df_forcing.name.values, quantity=df.quantity, allow_constant=False, add_interpolation=False, @@ -1225,7 +1225,7 @@ def read_meteo(df: pd.DataFrame, quantity: str) -> xr.DataArray: data, dims, coords, bc = _read_forcingfile( df_forcing, - index_coords="global", + index_values="global", quantity=quantity, allow_constant=True, add_interpolation=True, From 86ae1873c462d2c15d186bfe299d9808acf12a7d Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Tue, 28 Nov 2023 13:01:01 +0100 Subject: [PATCH 31/32] update private function _read_forcing_dataframe --- hydromt_delft3dfm/utils.py | 45 +++++++++----------------------------- 1 file changed, 10 insertions(+), 35 deletions(-) diff --git a/hydromt_delft3dfm/utils.py b/hydromt_delft3dfm/utils.py index 5a1bae48..727de892 100644 --- a/hydromt_delft3dfm/utils.py +++ b/hydromt_delft3dfm/utils.py @@ -594,13 +594,10 @@ def write_manholes(gdf: gpd.GeoDataFrame, savedir: str) -> str: return storage_fn -def _read_forcingfile( +def _read_forcing_dataframe( df_forcing: pd.DataFrame, index_values: Union[np.ndarray, str], quantity: str, - allow_constant: bool = True, - add_interpolation: bool = True, - add_factor_offset: bool = True, ) -> Tuple[np.ndarray, List, Dict, Dict]: """ Read forcing dataframe and parse to xarray properties. @@ -613,12 +610,6 @@ def _read_forcingfile( Index values of the forcing data. quantity: str Name of quantity (eg 'waterlevel'). - allow_constant: bool, optional - If True, allow constant forcing. - add_interpolation: bool, optional - If True, add timeinterpolation attribute. - add_factor_offset: bool, optional - If True, add factor and offset attributes. Returns ------- @@ -636,7 +627,7 @@ def _read_forcingfile( # Get data from forcing df # Check if all constant - if np.all(df_forcing.function == "constant") and allow_constant: + if np.all(df_forcing.function == "constant"): # Prepare data data = np.array([v[0][0] for v in df_forcing.datablock]) data = data + df_forcing.offset.values * df_forcing.factor.values @@ -645,9 +636,8 @@ def _read_forcingfile( coords = dict(index=index_values) bc["function"] = "constant" bc["units"] = df_forcing.quantityunitpair.iloc[0][0].unit - if add_factor_offset: - bc["factor"] = 1 - bc["offset"] = 0 + # bc["factor"] = 1 + # bc["offset"] = 0 # Check if all timeseries elif np.all(df_forcing.function == "timeseries"): # Prepare data @@ -665,20 +655,17 @@ def _read_forcingfile( dims = ["index", "time"] coords = dict(index=index_values, time=times) bc["function"] = "timeseries" - if add_interpolation: - bc["timeinterpolation"] = df_forcing.timeinterpolation.iloc[0] + bc["timeinterpolation"] = df_forcing.timeinterpolation.iloc[0] bc["units"] = df_forcing.quantityunitpair.iloc[0][1].unit bc["time_unit"] = df_forcing.quantityunitpair.iloc[0][0].unit - if add_factor_offset: - bc["factor"] = 1 - bc["offset"] = 0 + bc["factor"] = 1 + bc["offset"] = 0 # Else not implemented yet else: raise NotImplementedError( "ForcingFile with several function for a single variable not implemented." f"Skipping reading forcing for variable {quantity}." ) - return data, dims, coords, bc @@ -716,9 +703,6 @@ def read_1dboundary( df_forcing, index_values=nodeids, quantity=quantity, - allow_constant=True, - add_interpolation=False, - add_factor_offset=True, ) # Get nodeid coordinates @@ -874,13 +858,10 @@ def read_1dlateral( forcing = df.discharge.iloc[0] df_forcing = pd.DataFrame([f.__dict__ for f in forcing.forcing]) - data, dims, coords, bc = _read_forcingfile( + data, dims, coords, bc = _read_forcing_dataframe( df_forcing, index_values=df_forcing.name, quantity=quantity, - allow_constant=True, - add_interpolation=True, - add_factor_offset=True, ) # Get lateral locations and update dimentions and coordinates @@ -1081,13 +1062,10 @@ def read_2dboundary(df: pd.DataFrame, workdir: Path = Path.cwd()) -> xr.DataArra forcing = df.forcingfile df_forcing = pd.DataFrame([f.__dict__ for f in forcing.forcing]) - data, dims, coords, bc = _read_forcingfile( + data, dims, coords, bc = _read_forcing_dataframe( df_forcing, index_values=df_forcing.name.values, quantity=df.quantity, - allow_constant=False, - add_interpolation=False, - add_factor_offset=False, ) bc["locationfile"] = df.locationfile.filepath.name @@ -1223,13 +1201,10 @@ def read_meteo(df: pd.DataFrame, quantity: str) -> xr.DataArray: # Filter for the current nodes df_forcing = df_forcing[np.isin(df_forcing.name, "global")] - data, dims, coords, bc = _read_forcingfile( + data, dims, coords, bc = _read_forcing_dataframe( df_forcing, index_values="global", quantity=quantity, - allow_constant=True, - add_interpolation=True, - add_factor_offset=True, ) # Do not apply to "global" meteo # coords["x"] From e2149bbd014657329bafebe013f8498b7b507b35 Mon Sep 17 00:00:00 2001 From: Xiaohan Li Date: Tue, 28 Nov 2023 15:54:27 +0100 Subject: [PATCH 32/32] fix sonarcloud and precommit --- hydromt_delft3dfm/dflowfm.py | 1 + hydromt_delft3dfm/utils.py | 4 +- hydromt_delft3dfm/workflows/boundaries.py | 140 ++++++++++--------- hydromt_delft3dfm/workflows/crosssections.py | 1 + hydromt_delft3dfm/workflows/dem.py | 2 + 5 files changed, 83 insertions(+), 65 deletions(-) diff --git a/hydromt_delft3dfm/dflowfm.py b/hydromt_delft3dfm/dflowfm.py index 1a4160db..e6dbb80c 100644 --- a/hydromt_delft3dfm/dflowfm.py +++ b/hydromt_delft3dfm/dflowfm.py @@ -2451,6 +2451,7 @@ def setup_maps_from_raster_reclass( * **mapping_variables** maps: data from raster_mapping_fn spatially distributed with raster_fn + Parameters ---------- raster_fn: str diff --git a/hydromt_delft3dfm/utils.py b/hydromt_delft3dfm/utils.py index 727de892..7c30f2ee 100644 --- a/hydromt_delft3dfm/utils.py +++ b/hydromt_delft3dfm/utils.py @@ -179,7 +179,7 @@ def read_crosssections( """ def _list2Str(lst): - if type(lst) is list: + if isinstance(lst, list): # apply conversion to list columns if isinstance(lst[0], float): return " ".join(["{}".format(i) for i in lst]) @@ -699,7 +699,7 @@ def read_1dboundary( # Filter for the current nodes, remove nans df_forcing = df_forcing[np.isin(df_forcing.name, nodeids)] - data, dims, coords, bc = _read_forcingfile( + data, dims, coords, bc = _read_forcing_dataframe( df_forcing, index_values=nodeids, quantity=quantity, diff --git a/hydromt_delft3dfm/workflows/boundaries.py b/hydromt_delft3dfm/workflows/boundaries.py index 0cc5a5d7..416bf8ac 100644 --- a/hydromt_delft3dfm/workflows/boundaries.py +++ b/hydromt_delft3dfm/workflows/boundaries.py @@ -624,6 +624,23 @@ def compute_forcing_values_points( # first process data based on either timeseries or constant # then update data based on either nodes or branches # Timeseries forcing values + + # default dims, coords and attris for point geometry type + _dims_defaults = ["index"] + _coords_defaults = dict( + index=gdf.index, + x=("index", gdf.geometry.x.values), + y=("index", gdf.geometry.y.values), + branchid=("index", gdf.branchid.values), + chainage=("index", gdf.chainage.values), + ) + _attrs_defaults = dict( + offset=0.0, + factor=1.0, + quantity=f"{forcing_type}", + units=f"{forcing_unit}", + ) + if da is not None: logger.info(f"Preparing 1D forcing type {forcing_type} from timeseries.") @@ -631,26 +648,26 @@ def compute_forcing_values_points( bd_times, freq_name = _standardize_forcing_timeindexes(da) # instantiate xr.DataArray for forcing data - # NOTE only support points on branches - da_out = xr.DataArray( - data=da.data, - dims=["index", "time"], - coords=dict( - index=gdf.index, - time=bd_times, - x=("index", gdf.geometry.x.values), - y=("index", gdf.geometry.y.values), - branchid=("index", gdf.branchid.values), - chainage=("index", gdf.chainage.values), - ), - attrs=dict( + + # update dims, coords and attrs + _dims_defaults.append("time") + _coords_defaults.update(dict(time=bd_times)) + _attrs_defaults.update( + dict( function="TimeSeries", timeInterpolation="Linear", - quantity=f"{forcing_type}", - units=f"{forcing_unit}", time_unit=f"{freq_name} since {pd.to_datetime(da.time[0].values)}", - ), + ) ) + + # NOTE only support points on branches + da_out = xr.DataArray( + data=da.data, + dims=_dims_defaults, + coords=_coords_defaults, + attrs=_attrs_defaults, + ) + # fill in na using default da_out = da_out.fillna(forcing_value) @@ -661,24 +678,16 @@ def compute_forcing_values_points( da_out.name = f"{forcing_type}" else: logger.info(f"Use constant {forcing_value} {forcing_unit} for {forcing_type}.") + # instantiate xr.DataArray for bnd data with forcing_type directly + # update dims, coords and attrs + _attrs_defaults.update(dict(function="constant")) + da_out = xr.DataArray( data=np.full((len(gdf.index)), forcing_value, dtype=np.float32), - dims=["index"], - coords=dict( - index=gdf.index, - x=("index", gdf.geometry.x.values), - y=("index", gdf.geometry.y.values), - branchid=("index", gdf.branchid.values), - chainage=("index", gdf.chainage.values), - ), - attrs=dict( - function="constant", - offset=0.0, - factor=1.0, - quantity=f"{forcing_type}", - units=f"{forcing_unit}", - ), + dims=_dims_defaults, + coords=_coords_defaults, + attrs=_attrs_defaults, ) da_out.name = f"{forcing_type}" return da_out @@ -763,6 +772,16 @@ def compute_forcing_values_polygon( logger Logger to log messages. """ + # default dims, coords and attris for polygon geometry type + _dims_defaults = ["index", "numcoordinates"] + _coords_defaults = get_geometry_coords_for_polygons(gdf) + _attrs_defaults = dict( + offset=0.0, + factor=1.0, + quantity=f"{forcing_type}", + units=f"{forcing_unit}", + ) + # Timeseries forcing values if da is not None: logger.info(f"Preparing 1D forcing type {forcing_type} from timeseries.") @@ -771,29 +790,28 @@ def compute_forcing_values_polygon( bd_times, freq_name = _standardize_forcing_timeindexes(da) # instantiate xr.DataArray for forcing data - coords_dict = get_geometry_coords_for_polygons(gdf) + # Prepare the data data_3d = np.tile( - np.expand_dims(da.data, axis=-1), (1, 1, len(coords_dict["numcoordinates"])) + np.expand_dims(da.data, axis=-1), + (1, 1, len(_coords_defaults["numcoordinates"])), ) - # Create the DataArray - da_out = xr.DataArray( - data=data_3d, - dims=("index", "time", "numcoordinates"), - coords={ - "index": coords_dict["index"], - "numcoordinates": coords_dict["numcoordinates"], - "xcoordinates": coords_dict["xcoordinates"], - "ycoordinates": coords_dict["ycoordinates"], - "time": bd_times, - }, - attrs=dict( + # update dims, coords and attrs + _dims_defaults.insert(1, "time") + _coords_defaults.update(dict(time=bd_times)) + _attrs_defaults.update( + dict( function="TimeSeries", timeInterpolation="Linear", - quantity=f"{forcing_type}", - units=f"{forcing_unit}", time_unit=f"{freq_name} since {pd.to_datetime(da.time[0].values)}", - ), + ) + ) + # Create the DataArray + da_out = xr.DataArray( + data=data_3d, + dims=_dims_defaults, + coords=_coords_defaults, + attrs=_attrs_defaults, ) # fill in na using default da_out = da_out.fillna(forcing_value) @@ -805,28 +823,24 @@ def compute_forcing_values_polygon( da_out.name = f"{forcing_type}" else: logger.info(f"Use constant {forcing_value} {forcing_unit} for {forcing_type}.") + # instantiate xr.DataArray for forcing data with forcing_type directly - coords_dict = get_geometry_coords_for_polygons(gdf) + # Prepare the data data_3d = np.full( - (len(coords_dict["index"]), len(coords_dict["numcoordinates"])), + (len(_coords_defaults["index"]), len(_coords_defaults["numcoordinates"])), forcing_value, dtype=np.float32, ) + + # update dims, coords and attrs + _attrs_defaults.update(dict(function="constant")) + + # Create the DataArray da_out = xr.DataArray( data=data_3d, - coords={ - "index": coords_dict["index"], - "numcoordinates": coords_dict["numcoordinates"], - "xcoordinates": coords_dict["xcoordinates"], - "ycoordinates": coords_dict["ycoordinates"], - }, - attrs=dict( - function="constant", - offset=0.0, - factor=1.0, - quantity=f"{forcing_type}", - units=f"{forcing_unit}", - ), + dims=_dims_defaults, + coords=_coords_defaults, + attrs=_attrs_defaults, ) da_out.name = f"{forcing_type}" diff --git a/hydromt_delft3dfm/workflows/crosssections.py b/hydromt_delft3dfm/workflows/crosssections.py index 9cd785f8..4dcf07b6 100644 --- a/hydromt_delft3dfm/workflows/crosssections.py +++ b/hydromt_delft3dfm/workflows/crosssections.py @@ -551,6 +551,7 @@ def set_point_crosssections( maxdist : float, optional the maximum distant that a point crossection is snapped to the branch. By default 1.0 + Returns ------- gpd.GeoDataFrame diff --git a/hydromt_delft3dfm/workflows/dem.py b/hydromt_delft3dfm/workflows/dem.py index 7c5627c9..4abafe91 100644 --- a/hydromt_delft3dfm/workflows/dem.py +++ b/hydromt_delft3dfm/workflows/dem.py @@ -99,6 +99,7 @@ def get_rivbank_dz( Minimum threshold for valid river bank cells, by default 20 q : float, optional quantile [0-100] for river bank estimate, by default 25.0 + Returns ------- rivbank_dz: np.ndarray @@ -214,6 +215,7 @@ def get_river_bathymetry( river depth. constrain_rivbed : bool, optional If True (default) correct the river bed level to be hydrologically correct + Returns ------- gdf_riv: gpd.GeoDataFrame